From olk548 at mail.usask.ca Tue Aug 1 01:20:27 2017 From: olk548 at mail.usask.ca (Oleksandr Koshkarov) Date: Tue, 1 Aug 2017 00:20:27 -0600 Subject: [petsc-users] help me to solve 6-dim PDE with PETSc with advice In-Reply-To: References: <8ee93603-a928-52a4-2127-a647952ea116@mail.usask.ca> <63900532-C627-445F-BFAB-2943D385174E@mcs.anl.gov> <2ac0e117-9f4d-f93e-d768-69e2019d8972@mail.usask.ca> <7bb63e5e-d724-2079-add7-591e35084fa1@mail.usask.ca> Message-ID: <6f48bcf7-2120-0c61-e729-c05ca1c6e546@mail.usask.ca> Thank you, it is very helpful. I think there is a small problem with this approach. By storing E and B in DMDA I will communicate their values each time when I communicate ghost points. Moreover, it seems that each processor will have multiples copies of E and B (depending on how big velocity range it holds). So it seems it is possible to reduce communication and memory usage by 3 (maybe it is not a big number) if each process holds only one copy of E and B. However, if E and B will be stored in local vector, it is not obvious for me how to construct a time solver so it also evolves E and B all together with C. p.s. currently, I am still playing with PETSc manual and I started implementing the approach you proposed. Best regards, Oleksandr Koshkarov. On 07/30/2017 04:35 PM, Barry Smith wrote: >> On Jul 30, 2017, at 2:04 PM, Oleksandr Koshkarov wrote: >> >> Yes, It seems I am wrong and you are right. >> >> I think I can then make electric and magnetic fields local and do parallel partitioning only in v space - it will defiantly restrict the problem size, but maybe the code still be still useful and I get petsc experience with it :) The question here if I will just parallize along v-space, the 3d DMDA should be enough, right? I do not really understand how would I do the partitioning here, can you please give me some hints? > You could do this, it is tempting due to its simplicity. Let Mv,Nv, and Pv represent the number of grid points in the three velocity directions and Mx, Nx, Px represent the number of grid points in physical space. If you have three unknowns at each grid point represented by C, E, B then you would define > > dof = 3*Mx*Nx*Px > > Create your DMDACreate3d() using Mv,Nv, and Pv and dof then each process will have a certain number of velocity "grid" points and at each grid point there will room for all the physical points (times 3 for each unknown). So think of it as a three dimensional array with all the dependence on spatial grid point variables stacked up on top of each other. If you call > > DMDAVecGetArray() > > the resulting array will be indexed as > > array[kv][jv][iv][ilocal] > > where kv is the third grid component of velocity etc and ilocal goes from 0 to 3*Mx*Nx*Px. You can decide if you want to store the C, E, B interlaced (meaning array[kv][jv][iv][0] is the first C, array[kv][jv][iv][1] is the first E ...) or uninterlaced (meaning array[kv][jv][iv][0:Mx*Nx*Px] are the C etc). If you use noninterlaced then applying a 3d FFT to a particular component is straightforward since they are all stored next to each other. > > This is definitely not a scalable approach but you might be able to have Mx = My = Mz = 128 which is not bad for a spectral method. > > I recommend starting by writing a simple code that does this first with 2d spatial and 2d, it is just so much easy to reason about a two array as you get the kinks out of the code. > > Barry > > > > > >> Another approach is to abandon global Fourier, let say for education purposes I will pick some finite difference along spacial dimensions, how would you advice me to partition this problem with PETSc then? >> >> >> I know something like spectral elements or discontinuous Galerkin will be ideal, but I want to get petsc experience first with simpler problem and then move to discontinuous Galerkin (this will be defiantly the next step). (Unfortunately, I have never done any unstructured meshes like spectral elements or discontinuous Galerkin myself before, but did some finite difference and spectral methods) >> >> On 07/30/2017 12:46 PM, Matthew Knepley wrote: >>> On Sun, Jul 30, 2017 at 12:44 PM, Oleksandr Koshkarov wrote: >>> Thanks for the references, and warning. >>> >>> I am trying to do exactly this >>> http://www.sciencedirect.com/science/article/pii/S0021999115004738 >>> >>> (I probably should have added the reference in the first place, sorry) >>> >>> the evolution formula is (15) in the article. >>> >>> So, I will do convolution only in 3D (while full system is 6D) because velocity space is not discretized with Fourier >>> >>> So As I understand, it will not be N^2 vs N logN. Moreover, I know that algorithm with FFT has significantly larger "constant". >>> >>> Please correct me if I am wrong here :) >>> >>> I think you are wrong here. First, I do not understand why you think the asymptotics have changed. Second, the constant for >>> FFT is about 6, which would be really hard to beat with a quadrature. >>> >>> Last, this discretization looks fully coupled to me. I cannot see how you would parallelize this right off the bat. This is a problem >>> with spectral discretizations, and the main motivator for spectral elements. >>> >>> Thanks, >>> >>> Matt >>> I know for sure that FFT is a must at the end, but I thought I can start with matrix product to get more familiar with PETSc as it will be simpler to implement (At least I think so). >>> >>> I hope it does make sense. >>> >>> Another question about convolution via matrix product. Is there better way to do it other then to construct NxN Toeplitz-like matrix each time step on the "fly" from state vector and then multiply it to state vector? >>> >>> p.s. Probably I should do FFT from the start, but I am a little bit intimidated by the problem taking into account that I do not have PETSc experience. >>> Best regards, >>> Oleksandr Koshkarov. >>> >>> On 07/30/2017 09:01 AM, Matthew Knepley wrote: >>>> On Sat, Jul 29, 2017 at 7:01 PM, Oleksandr Koshkarov wrote: >>>> Thank you for the response, >>>> >>>> Now that you said about additional communication for fft, I want to ask another question: >>>> >>>> What if I disregard FFT and will compute convolution directly, I will rewrite it as vector-matrix-vector product >>>> >>>> I would caution you here. The algorithm is the most important thing to get right up front. In this case, the effect of >>>> dimension will be dominant, and anything that does not scale well with dimension will be thrown away, perhaps >>>> quite quickly, as you want to solve bigger problems. >>>> >>>> Small calculation: Take a 6-dim box which is 'n' on a side, so that N = n^6. FFT is N log N, whereas direct evaluation of >>>> a convolution is N^2. So if we could do n = 100 points on a side with FFT, you can do, assuming the constants are about >>>> equal, >>>> >>>> 100^6 (log 100^6) = x^12 >>>> 1e12 (6 2) = x^12 >>>> x ~ 10 >>>> >>>> Past versions of PETSc had a higher dimensional DA construct (adda in prior versions), but no one used it so we removed it. >>>> >>>> I assume you are proposing something like >>>> >>>> https://arxiv.org/abs/1306.4625 >>>> >>>> or maybe >>>> >>>> https://arxiv.org/abs/1610.00397 >>>> >>>> The later is interesting since I think you could use a DMDA for the velocity and something like DMPlex for the space. >>>> >>>> Thanks, >>>> >>>> Matt >>>> >>>> x^T A x (where T - is transpose, x - is my state vector, and A is a matrix which represents convolution and probably it will be not very sparse). >>>> >>>> Yes - I will do more work (alghorithm will be slower), but will I win if we take the parallelization into account - less communication + probably more scalable algorithm? >>>> >>>> Best regards, >>>> >>>> Alex. >>>> >>>> >>>> >>>> On 07/29/2017 05:23 PM, Barry Smith wrote: >>>> DMDA provides a simple way to do domain decomposition of structured grid meshes in the x, y, and z direction, that is it makes it easy to efficiently chop up vectors in all 3 dimensions, allowing very large problems easily. Unfortunately it only goes up to 3 dimensions and attempts to produce versions for higher dimensions have failed. >>>> >>>> If you would like to do domain decomposition across all six of your dimensions (which I think you really need to do to solve large problems) we don't have a tool that helps with doing the domain decomposition. To make matters more complicated, likely the 3d mpi-fftw that need to be applied require rejiggering the data across the nodes to get it into a form where the ffts can be applied efficiently. >>>> >>>> I don't think there is necessarily anything theoretically difficult about managing the six dimensional domain decomposition I just don't know of any open source software out there that helps to do this. Maybe some PETSc users are aware of such software and can chime in. >>>> >>>> Aside from these two issues :-) PETSc would be useful for you since you could use our time integrators and nonlinear solvers. Pulling out subvectors to process on can be done with with either VecScatter or VecStrideScatter, VecStrideGather etc depending on the layout of the unknowns, i.e. how the domain decomposition is done. >>>> >>>> I wish I had better answers for managing the 6d domain decomposition >>>> >>>> Barry >>>> >>>> >>>> >>>> >>>> On Jul 29, 2017, at 5:06 PM, Oleksandr Koshkarov wrote: >>>> >>>> Dear All, >>>> >>>> I am a new PETSc user and I am still in the middle of the manual (I have finally settled to choose PETSc as my main numerical library) so I am sorry beforehand if my questions would be naive. >>>> >>>> I am trying to solve 6+1 dimensional Vlasov equation with spectral methods. More precisely, I will try to solve half-discretized equations of the form (approximate form) with pseudospectral Fourier method: >>>> >>>> (Equations are in latex format, the nice website to see them is https://www.codecogs.com/latex/eqneditor.php) >>>> >>>> \frac{dC_{m,m,p}}{dt} =\\ >>>> \partial_x \left ( a_n C_{n+1,m,p} +b_n C_{n,m,p} +c_n C_{n-1,m,p} \right ) \\ >>>> + \partial_y \left ( a_m C_{n,m+1,p} +b_m C_{n,m,p} +c_m C_{n,m-1,p} \right ) \\ >>>> + \partial_z \left ( a_p C_{n,m,p+1} +b_p C_{n,m,p} +c_p C_{n,m,p-1} \right ) \\ >>>> + d_n E_x C_{n-1,m,p} + d_m E_x C_{n,m-1,p} + d_p E_x C_{n,m,p-1} \\ >>>> + B_x (e_{m,p} C_{n,m-1,p-1} + f_{m,p}C_{n,m-1,p+1} + \dots) + B_y (\dots) + B_z (\dots) >>>> >>>> >>>> where a,b,c,d,e,f are some constants which can depend on n,m,p, >>>> >>>> n,m,p = 0...N, >>>> >>>> C_{n,m,p} = C_{n,m,p}(x,y,z), >>>> >>>> E_x = E_x(x,y,z), (same for E_y,B_x,...) >>>> >>>> and fields are described with equation of the sort (linear pdes with source terms dependent on C): >>>> >>>> \frac{dE_x}{dt} = \partial_y B_z - \partial_z B_x + (AC_{1,0,0} + BC_{0,0,0}) \\ >>>> \frac{dB_x}{dt} = -\partial_y E_z + \partial_z E_x >>>> >>>> with A,B being some constants. >>>> >>>> I will need fully implicit Crank?Nicolson method, so my plan is to use SNES or TS where >>>> >>>> I will use one MPI PETSc vector which describes the state of the system (all, C, E, B), then I can evolve linear part with just matrix multiplication. >>>> >>>> The first question is, should I use something like DMDA? if so, it is only 3dimensional but I need 6 dimensional vectots? Will it be faster then matrix multiplication? >>>> >>>> Then to do nonlinear part I will need 3d mpi-fftw to compute convolutions. The problem is, how do I extract subvectors from full big vector state? (what is the best approach?) >>>> >>>> If you have some other suggestions, please feel free to share >>>> >>>> Thanks and best regards, >>>> >>>> Oleksandr Koshkarov. >>>> >>>> >>>> >>>> >>>> >>>> -- >>>> What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. >>>> -- Norbert Wiener >>>> >>>> http://www.caam.rice.edu/~mk51/ >>> >>> >>> >>> -- >>> What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. >>> -- Norbert Wiener >>> >>> http://www.caam.rice.edu/~mk51/ From bsmith at mcs.anl.gov Tue Aug 1 11:35:29 2017 From: bsmith at mcs.anl.gov (Barry Smith) Date: Tue, 1 Aug 2017 11:35:29 -0500 Subject: [petsc-users] help me to solve 6-dim PDE with PETSc with advice In-Reply-To: <6f48bcf7-2120-0c61-e729-c05ca1c6e546@mail.usask.ca> References: <8ee93603-a928-52a4-2127-a647952ea116@mail.usask.ca> <63900532-C627-445F-BFAB-2943D385174E@mcs.anl.gov> <2ac0e117-9f4d-f93e-d768-69e2019d8972@mail.usask.ca> <7bb63e5e-d724-2079-add7-591e35084fa1@mail.usask.ca> <6f48bcf7-2120-0c61-e729-c05ca1c6e546@mail.usask.ca> Message-ID: > On Aug 1, 2017, at 1:20 AM, Oleksandr Koshkarov wrote: > > Thank you, it is very helpful. > > I think there is a small problem with this approach. By storing E and B in DMDA I will communicate their values each time when I communicate ghost points. Moreover, it seems that each processor will have multiples copies of E and B (depending on how big velocity range it holds). So it seems it is possible to reduce communication and memory usage by 3 (maybe it is not a big number) if each process holds only one copy of E and B. However, if E and B will be stored in local vector, it is not obvious for me how to construct a time solver so it also evolves E and B all together with C. > So you are saying that E and B don't have any coupling between values at different velocities and hence don't need ghost points? DMDA is simple, it doesn't have support for only have ghost points for some variables but should the communication prove to be time-consuming we could provide a custom version that does not ghost-point the E and B. It is just an optimization and you shouldn't worry about it until you have working code. Barry > p.s. currently, I am still playing with PETSc manual and I started implementing the approach you proposed. > > Best regards, > > Oleksandr Koshkarov. > > > On 07/30/2017 04:35 PM, Barry Smith wrote: >>> On Jul 30, 2017, at 2:04 PM, Oleksandr Koshkarov wrote: >>> >>> Yes, It seems I am wrong and you are right. >>> >>> I think I can then make electric and magnetic fields local and do parallel partitioning only in v space - it will defiantly restrict the problem size, but maybe the code still be still useful and I get petsc experience with it :) The question here if I will just parallize along v-space, the 3d DMDA should be enough, right? I do not really understand how would I do the partitioning here, can you please give me some hints? >> You could do this, it is tempting due to its simplicity. Let Mv,Nv, and Pv represent the number of grid points in the three velocity directions and Mx, Nx, Px represent the number of grid points in physical space. If you have three unknowns at each grid point represented by C, E, B then you would define >> >> dof = 3*Mx*Nx*Px >> >> Create your DMDACreate3d() using Mv,Nv, and Pv and dof then each process will have a certain number of velocity "grid" points and at each grid point there will room for all the physical points (times 3 for each unknown). So think of it as a three dimensional array with all the dependence on spatial grid point variables stacked up on top of each other. If you call >> >> DMDAVecGetArray() >> >> the resulting array will be indexed as >> >> array[kv][jv][iv][ilocal] >> >> where kv is the third grid component of velocity etc and ilocal goes from 0 to 3*Mx*Nx*Px. You can decide if you want to store the C, E, B interlaced (meaning array[kv][jv][iv][0] is the first C, array[kv][jv][iv][1] is the first E ...) or uninterlaced (meaning array[kv][jv][iv][0:Mx*Nx*Px] are the C etc). If you use noninterlaced then applying a 3d FFT to a particular component is straightforward since they are all stored next to each other. >> >> This is definitely not a scalable approach but you might be able to have Mx = My = Mz = 128 which is not bad for a spectral method. >> >> I recommend starting by writing a simple code that does this first with 2d spatial and 2d, it is just so much easy to reason about a two array as you get the kinks out of the code. >> >> Barry >> >> >> >> >> >>> Another approach is to abandon global Fourier, let say for education purposes I will pick some finite difference along spacial dimensions, how would you advice me to partition this problem with PETSc then? >>> >>> >>> I know something like spectral elements or discontinuous Galerkin will be ideal, but I want to get petsc experience first with simpler problem and then move to discontinuous Galerkin (this will be defiantly the next step). (Unfortunately, I have never done any unstructured meshes like spectral elements or discontinuous Galerkin myself before, but did some finite difference and spectral methods) >>> >>> On 07/30/2017 12:46 PM, Matthew Knepley wrote: >>>> On Sun, Jul 30, 2017 at 12:44 PM, Oleksandr Koshkarov wrote: >>>> Thanks for the references, and warning. >>>> >>>> I am trying to do exactly this >>>> http://www.sciencedirect.com/science/article/pii/S0021999115004738 >>>> >>>> (I probably should have added the reference in the first place, sorry) >>>> >>>> the evolution formula is (15) in the article. >>>> >>>> So, I will do convolution only in 3D (while full system is 6D) because velocity space is not discretized with Fourier >>>> >>>> So As I understand, it will not be N^2 vs N logN. Moreover, I know that algorithm with FFT has significantly larger "constant". >>>> >>>> Please correct me if I am wrong here :) >>>> >>>> I think you are wrong here. First, I do not understand why you think the asymptotics have changed. Second, the constant for >>>> FFT is about 6, which would be really hard to beat with a quadrature. >>>> >>>> Last, this discretization looks fully coupled to me. I cannot see how you would parallelize this right off the bat. This is a problem >>>> with spectral discretizations, and the main motivator for spectral elements. >>>> >>>> Thanks, >>>> >>>> Matt >>>> I know for sure that FFT is a must at the end, but I thought I can start with matrix product to get more familiar with PETSc as it will be simpler to implement (At least I think so). >>>> >>>> I hope it does make sense. >>>> >>>> Another question about convolution via matrix product. Is there better way to do it other then to construct NxN Toeplitz-like matrix each time step on the "fly" from state vector and then multiply it to state vector? >>>> >>>> p.s. Probably I should do FFT from the start, but I am a little bit intimidated by the problem taking into account that I do not have PETSc experience. >>>> Best regards, >>>> Oleksandr Koshkarov. >>>> >>>> On 07/30/2017 09:01 AM, Matthew Knepley wrote: >>>>> On Sat, Jul 29, 2017 at 7:01 PM, Oleksandr Koshkarov wrote: >>>>> Thank you for the response, >>>>> >>>>> Now that you said about additional communication for fft, I want to ask another question: >>>>> >>>>> What if I disregard FFT and will compute convolution directly, I will rewrite it as vector-matrix-vector product >>>>> >>>>> I would caution you here. The algorithm is the most important thing to get right up front. In this case, the effect of >>>>> dimension will be dominant, and anything that does not scale well with dimension will be thrown away, perhaps >>>>> quite quickly, as you want to solve bigger problems. >>>>> >>>>> Small calculation: Take a 6-dim box which is 'n' on a side, so that N = n^6. FFT is N log N, whereas direct evaluation of >>>>> a convolution is N^2. So if we could do n = 100 points on a side with FFT, you can do, assuming the constants are about >>>>> equal, >>>>> >>>>> 100^6 (log 100^6) = x^12 >>>>> 1e12 (6 2) = x^12 >>>>> x ~ 10 >>>>> >>>>> Past versions of PETSc had a higher dimensional DA construct (adda in prior versions), but no one used it so we removed it. >>>>> >>>>> I assume you are proposing something like >>>>> >>>>> https://arxiv.org/abs/1306.4625 >>>>> >>>>> or maybe >>>>> >>>>> https://arxiv.org/abs/1610.00397 >>>>> >>>>> The later is interesting since I think you could use a DMDA for the velocity and something like DMPlex for the space. >>>>> >>>>> Thanks, >>>>> >>>>> Matt >>>>> >>>>> x^T A x (where T - is transpose, x - is my state vector, and A is a matrix which represents convolution and probably it will be not very sparse). >>>>> >>>>> Yes - I will do more work (alghorithm will be slower), but will I win if we take the parallelization into account - less communication + probably more scalable algorithm? >>>>> >>>>> Best regards, >>>>> >>>>> Alex. >>>>> >>>>> >>>>> >>>>> On 07/29/2017 05:23 PM, Barry Smith wrote: >>>>> DMDA provides a simple way to do domain decomposition of structured grid meshes in the x, y, and z direction, that is it makes it easy to efficiently chop up vectors in all 3 dimensions, allowing very large problems easily. Unfortunately it only goes up to 3 dimensions and attempts to produce versions for higher dimensions have failed. >>>>> >>>>> If you would like to do domain decomposition across all six of your dimensions (which I think you really need to do to solve large problems) we don't have a tool that helps with doing the domain decomposition. To make matters more complicated, likely the 3d mpi-fftw that need to be applied require rejiggering the data across the nodes to get it into a form where the ffts can be applied efficiently. >>>>> >>>>> I don't think there is necessarily anything theoretically difficult about managing the six dimensional domain decomposition I just don't know of any open source software out there that helps to do this. Maybe some PETSc users are aware of such software and can chime in. >>>>> >>>>> Aside from these two issues :-) PETSc would be useful for you since you could use our time integrators and nonlinear solvers. Pulling out subvectors to process on can be done with with either VecScatter or VecStrideScatter, VecStrideGather etc depending on the layout of the unknowns, i.e. how the domain decomposition is done. >>>>> >>>>> I wish I had better answers for managing the 6d domain decomposition >>>>> >>>>> Barry >>>>> >>>>> >>>>> >>>>> >>>>> On Jul 29, 2017, at 5:06 PM, Oleksandr Koshkarov wrote: >>>>> >>>>> Dear All, >>>>> >>>>> I am a new PETSc user and I am still in the middle of the manual (I have finally settled to choose PETSc as my main numerical library) so I am sorry beforehand if my questions would be naive. >>>>> >>>>> I am trying to solve 6+1 dimensional Vlasov equation with spectral methods. More precisely, I will try to solve half-discretized equations of the form (approximate form) with pseudospectral Fourier method: >>>>> >>>>> (Equations are in latex format, the nice website to see them is https://www.codecogs.com/latex/eqneditor.php) >>>>> >>>>> \frac{dC_{m,m,p}}{dt} =\\ >>>>> \partial_x \left ( a_n C_{n+1,m,p} +b_n C_{n,m,p} +c_n C_{n-1,m,p} \right ) \\ >>>>> + \partial_y \left ( a_m C_{n,m+1,p} +b_m C_{n,m,p} +c_m C_{n,m-1,p} \right ) \\ >>>>> + \partial_z \left ( a_p C_{n,m,p+1} +b_p C_{n,m,p} +c_p C_{n,m,p-1} \right ) \\ >>>>> + d_n E_x C_{n-1,m,p} + d_m E_x C_{n,m-1,p} + d_p E_x C_{n,m,p-1} \\ >>>>> + B_x (e_{m,p} C_{n,m-1,p-1} + f_{m,p}C_{n,m-1,p+1} + \dots) + B_y (\dots) + B_z (\dots) >>>>> >>>>> >>>>> where a,b,c,d,e,f are some constants which can depend on n,m,p, >>>>> >>>>> n,m,p = 0...N, >>>>> >>>>> C_{n,m,p} = C_{n,m,p}(x,y,z), >>>>> >>>>> E_x = E_x(x,y,z), (same for E_y,B_x,...) >>>>> >>>>> and fields are described with equation of the sort (linear pdes with source terms dependent on C): >>>>> >>>>> \frac{dE_x}{dt} = \partial_y B_z - \partial_z B_x + (AC_{1,0,0} + BC_{0,0,0}) \\ >>>>> \frac{dB_x}{dt} = -\partial_y E_z + \partial_z E_x >>>>> >>>>> with A,B being some constants. >>>>> >>>>> I will need fully implicit Crank?Nicolson method, so my plan is to use SNES or TS where >>>>> >>>>> I will use one MPI PETSc vector which describes the state of the system (all, C, E, B), then I can evolve linear part with just matrix multiplication. >>>>> >>>>> The first question is, should I use something like DMDA? if so, it is only 3dimensional but I need 6 dimensional vectots? Will it be faster then matrix multiplication? >>>>> >>>>> Then to do nonlinear part I will need 3d mpi-fftw to compute convolutions. The problem is, how do I extract subvectors from full big vector state? (what is the best approach?) >>>>> >>>>> If you have some other suggestions, please feel free to share >>>>> >>>>> Thanks and best regards, >>>>> >>>>> Oleksandr Koshkarov. >>>>> >>>>> >>>>> >>>>> >>>>> >>>>> -- >>>>> What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. >>>>> -- Norbert Wiener >>>>> >>>>> http://www.caam.rice.edu/~mk51/ >>>> >>>> >>>> >>>> -- >>>> What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. >>>> -- Norbert Wiener >>>> >>>> http://www.caam.rice.edu/~mk51/ > From olk548 at mail.usask.ca Tue Aug 1 11:43:17 2017 From: olk548 at mail.usask.ca (Oleksandr Koshkarov) Date: Tue, 1 Aug 2017 10:43:17 -0600 Subject: [petsc-users] help me to solve 6-dim PDE with PETSc with advice In-Reply-To: References: <8ee93603-a928-52a4-2127-a647952ea116@mail.usask.ca> <63900532-C627-445F-BFAB-2943D385174E@mcs.anl.gov> <2ac0e117-9f4d-f93e-d768-69e2019d8972@mail.usask.ca> <7bb63e5e-d724-2079-add7-591e35084fa1@mail.usask.ca> <6f48bcf7-2120-0c61-e729-c05ca1c6e546@mail.usask.ca> Message-ID: > So you are saying that E and B don't have any coupling between values at different velocities and hence don't need ghost points? Yes, exactly - E and B depend only on space coordinates. > It is just an optimization and you shouldn't worry about it until you have working code. OK, thanks, that is what I will do. Oleksandr Koshkarov On 08/01/2017 10:35 AM, Barry Smith wrote: >> On Aug 1, 2017, at 1:20 AM, Oleksandr Koshkarov wrote: >> >> Thank you, it is very helpful. >> >> I think there is a small problem with this approach. By storing E and B in DMDA I will communicate their values each time when I communicate ghost points. Moreover, it seems that each processor will have multiples copies of E and B (depending on how big velocity range it holds). So it seems it is possible to reduce communication and memory usage by 3 (maybe it is not a big number) if each process holds only one copy of E and B. However, if E and B will be stored in local vector, it is not obvious for me how to construct a time solver so it also evolves E and B all together with C. >> > So you are saying that E and B don't have any coupling between values at different velocities and hence don't need ghost points? DMDA is simple, it doesn't have support for only have ghost points for some variables but should the communication prove to be time-consuming we could provide a custom version that does not ghost-point the E and B. It is just an optimization and you shouldn't worry about it until you have working code. > > Barry > > >> p.s. currently, I am still playing with PETSc manual and I started implementing the approach you proposed. >> >> Best regards, >> >> Oleksandr Koshkarov. >> >> >> On 07/30/2017 04:35 PM, Barry Smith wrote: >>>> On Jul 30, 2017, at 2:04 PM, Oleksandr Koshkarov wrote: >>>> >>>> Yes, It seems I am wrong and you are right. >>>> >>>> I think I can then make electric and magnetic fields local and do parallel partitioning only in v space - it will defiantly restrict the problem size, but maybe the code still be still useful and I get petsc experience with it :) The question here if I will just parallize along v-space, the 3d DMDA should be enough, right? I do not really understand how would I do the partitioning here, can you please give me some hints? >>> You could do this, it is tempting due to its simplicity. Let Mv,Nv, and Pv represent the number of grid points in the three velocity directions and Mx, Nx, Px represent the number of grid points in physical space. If you have three unknowns at each grid point represented by C, E, B then you would define >>> >>> dof = 3*Mx*Nx*Px >>> >>> Create your DMDACreate3d() using Mv,Nv, and Pv and dof then each process will have a certain number of velocity "grid" points and at each grid point there will room for all the physical points (times 3 for each unknown). So think of it as a three dimensional array with all the dependence on spatial grid point variables stacked up on top of each other. If you call >>> >>> DMDAVecGetArray() >>> >>> the resulting array will be indexed as >>> >>> array[kv][jv][iv][ilocal] >>> >>> where kv is the third grid component of velocity etc and ilocal goes from 0 to 3*Mx*Nx*Px. You can decide if you want to store the C, E, B interlaced (meaning array[kv][jv][iv][0] is the first C, array[kv][jv][iv][1] is the first E ...) or uninterlaced (meaning array[kv][jv][iv][0:Mx*Nx*Px] are the C etc). If you use noninterlaced then applying a 3d FFT to a particular component is straightforward since they are all stored next to each other. >>> >>> This is definitely not a scalable approach but you might be able to have Mx = My = Mz = 128 which is not bad for a spectral method. >>> >>> I recommend starting by writing a simple code that does this first with 2d spatial and 2d, it is just so much easy to reason about a two array as you get the kinks out of the code. >>> >>> Barry >>> >>> >>> >>> >>> >>>> Another approach is to abandon global Fourier, let say for education purposes I will pick some finite difference along spacial dimensions, how would you advice me to partition this problem with PETSc then? >>>> >>>> >>>> I know something like spectral elements or discontinuous Galerkin will be ideal, but I want to get petsc experience first with simpler problem and then move to discontinuous Galerkin (this will be defiantly the next step). (Unfortunately, I have never done any unstructured meshes like spectral elements or discontinuous Galerkin myself before, but did some finite difference and spectral methods) >>>> >>>> On 07/30/2017 12:46 PM, Matthew Knepley wrote: >>>>> On Sun, Jul 30, 2017 at 12:44 PM, Oleksandr Koshkarov wrote: >>>>> Thanks for the references, and warning. >>>>> >>>>> I am trying to do exactly this >>>>> http://www.sciencedirect.com/science/article/pii/S0021999115004738 >>>>> >>>>> (I probably should have added the reference in the first place, sorry) >>>>> >>>>> the evolution formula is (15) in the article. >>>>> >>>>> So, I will do convolution only in 3D (while full system is 6D) because velocity space is not discretized with Fourier >>>>> >>>>> So As I understand, it will not be N^2 vs N logN. Moreover, I know that algorithm with FFT has significantly larger "constant". >>>>> >>>>> Please correct me if I am wrong here :) >>>>> >>>>> I think you are wrong here. First, I do not understand why you think the asymptotics have changed. Second, the constant for >>>>> FFT is about 6, which would be really hard to beat with a quadrature. >>>>> >>>>> Last, this discretization looks fully coupled to me. I cannot see how you would parallelize this right off the bat. This is a problem >>>>> with spectral discretizations, and the main motivator for spectral elements. >>>>> >>>>> Thanks, >>>>> >>>>> Matt >>>>> I know for sure that FFT is a must at the end, but I thought I can start with matrix product to get more familiar with PETSc as it will be simpler to implement (At least I think so). >>>>> >>>>> I hope it does make sense. >>>>> >>>>> Another question about convolution via matrix product. Is there better way to do it other then to construct NxN Toeplitz-like matrix each time step on the "fly" from state vector and then multiply it to state vector? >>>>> >>>>> p.s. Probably I should do FFT from the start, but I am a little bit intimidated by the problem taking into account that I do not have PETSc experience. >>>>> Best regards, >>>>> Oleksandr Koshkarov. >>>>> >>>>> On 07/30/2017 09:01 AM, Matthew Knepley wrote: >>>>>> On Sat, Jul 29, 2017 at 7:01 PM, Oleksandr Koshkarov wrote: >>>>>> Thank you for the response, >>>>>> >>>>>> Now that you said about additional communication for fft, I want to ask another question: >>>>>> >>>>>> What if I disregard FFT and will compute convolution directly, I will rewrite it as vector-matrix-vector product >>>>>> >>>>>> I would caution you here. The algorithm is the most important thing to get right up front. In this case, the effect of >>>>>> dimension will be dominant, and anything that does not scale well with dimension will be thrown away, perhaps >>>>>> quite quickly, as you want to solve bigger problems. >>>>>> >>>>>> Small calculation: Take a 6-dim box which is 'n' on a side, so that N = n^6. FFT is N log N, whereas direct evaluation of >>>>>> a convolution is N^2. So if we could do n = 100 points on a side with FFT, you can do, assuming the constants are about >>>>>> equal, >>>>>> >>>>>> 100^6 (log 100^6) = x^12 >>>>>> 1e12 (6 2) = x^12 >>>>>> x ~ 10 >>>>>> >>>>>> Past versions of PETSc had a higher dimensional DA construct (adda in prior versions), but no one used it so we removed it. >>>>>> >>>>>> I assume you are proposing something like >>>>>> >>>>>> https://arxiv.org/abs/1306.4625 >>>>>> >>>>>> or maybe >>>>>> >>>>>> https://arxiv.org/abs/1610.00397 >>>>>> >>>>>> The later is interesting since I think you could use a DMDA for the velocity and something like DMPlex for the space. >>>>>> >>>>>> Thanks, >>>>>> >>>>>> Matt >>>>>> >>>>>> x^T A x (where T - is transpose, x - is my state vector, and A is a matrix which represents convolution and probably it will be not very sparse). >>>>>> >>>>>> Yes - I will do more work (alghorithm will be slower), but will I win if we take the parallelization into account - less communication + probably more scalable algorithm? >>>>>> >>>>>> Best regards, >>>>>> >>>>>> Alex. >>>>>> >>>>>> >>>>>> >>>>>> On 07/29/2017 05:23 PM, Barry Smith wrote: >>>>>> DMDA provides a simple way to do domain decomposition of structured grid meshes in the x, y, and z direction, that is it makes it easy to efficiently chop up vectors in all 3 dimensions, allowing very large problems easily. Unfortunately it only goes up to 3 dimensions and attempts to produce versions for higher dimensions have failed. >>>>>> >>>>>> If you would like to do domain decomposition across all six of your dimensions (which I think you really need to do to solve large problems) we don't have a tool that helps with doing the domain decomposition. To make matters more complicated, likely the 3d mpi-fftw that need to be applied require rejiggering the data across the nodes to get it into a form where the ffts can be applied efficiently. >>>>>> >>>>>> I don't think there is necessarily anything theoretically difficult about managing the six dimensional domain decomposition I just don't know of any open source software out there that helps to do this. Maybe some PETSc users are aware of such software and can chime in. >>>>>> >>>>>> Aside from these two issues :-) PETSc would be useful for you since you could use our time integrators and nonlinear solvers. Pulling out subvectors to process on can be done with with either VecScatter or VecStrideScatter, VecStrideGather etc depending on the layout of the unknowns, i.e. how the domain decomposition is done. >>>>>> >>>>>> I wish I had better answers for managing the 6d domain decomposition >>>>>> >>>>>> Barry >>>>>> >>>>>> >>>>>> >>>>>> >>>>>> On Jul 29, 2017, at 5:06 PM, Oleksandr Koshkarov wrote: >>>>>> >>>>>> Dear All, >>>>>> >>>>>> I am a new PETSc user and I am still in the middle of the manual (I have finally settled to choose PETSc as my main numerical library) so I am sorry beforehand if my questions would be naive. >>>>>> >>>>>> I am trying to solve 6+1 dimensional Vlasov equation with spectral methods. More precisely, I will try to solve half-discretized equations of the form (approximate form) with pseudospectral Fourier method: >>>>>> >>>>>> (Equations are in latex format, the nice website to see them is https://www.codecogs.com/latex/eqneditor.php) >>>>>> >>>>>> \frac{dC_{m,m,p}}{dt} =\\ >>>>>> \partial_x \left ( a_n C_{n+1,m,p} +b_n C_{n,m,p} +c_n C_{n-1,m,p} \right ) \\ >>>>>> + \partial_y \left ( a_m C_{n,m+1,p} +b_m C_{n,m,p} +c_m C_{n,m-1,p} \right ) \\ >>>>>> + \partial_z \left ( a_p C_{n,m,p+1} +b_p C_{n,m,p} +c_p C_{n,m,p-1} \right ) \\ >>>>>> + d_n E_x C_{n-1,m,p} + d_m E_x C_{n,m-1,p} + d_p E_x C_{n,m,p-1} \\ >>>>>> + B_x (e_{m,p} C_{n,m-1,p-1} + f_{m,p}C_{n,m-1,p+1} + \dots) + B_y (\dots) + B_z (\dots) >>>>>> >>>>>> >>>>>> where a,b,c,d,e,f are some constants which can depend on n,m,p, >>>>>> >>>>>> n,m,p = 0...N, >>>>>> >>>>>> C_{n,m,p} = C_{n,m,p}(x,y,z), >>>>>> >>>>>> E_x = E_x(x,y,z), (same for E_y,B_x,...) >>>>>> >>>>>> and fields are described with equation of the sort (linear pdes with source terms dependent on C): >>>>>> >>>>>> \frac{dE_x}{dt} = \partial_y B_z - \partial_z B_x + (AC_{1,0,0} + BC_{0,0,0}) \\ >>>>>> \frac{dB_x}{dt} = -\partial_y E_z + \partial_z E_x >>>>>> >>>>>> with A,B being some constants. >>>>>> >>>>>> I will need fully implicit Crank?Nicolson method, so my plan is to use SNES or TS where >>>>>> >>>>>> I will use one MPI PETSc vector which describes the state of the system (all, C, E, B), then I can evolve linear part with just matrix multiplication. >>>>>> >>>>>> The first question is, should I use something like DMDA? if so, it is only 3dimensional but I need 6 dimensional vectots? Will it be faster then matrix multiplication? >>>>>> >>>>>> Then to do nonlinear part I will need 3d mpi-fftw to compute convolutions. The problem is, how do I extract subvectors from full big vector state? (what is the best approach?) >>>>>> >>>>>> If you have some other suggestions, please feel free to share >>>>>> >>>>>> Thanks and best regards, >>>>>> >>>>>> Oleksandr Koshkarov. >>>>>> >>>>>> >>>>>> >>>>>> >>>>>> >>>>>> -- >>>>>> What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. >>>>>> -- Norbert Wiener >>>>>> >>>>>> http://www.caam.rice.edu/~mk51/ >>>>> >>>>> >>>>> -- >>>>> What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. >>>>> -- Norbert Wiener >>>>> >>>>> http://www.caam.rice.edu/~mk51/ From bsmith at mcs.anl.gov Tue Aug 1 11:56:01 2017 From: bsmith at mcs.anl.gov (Barry Smith) Date: Tue, 1 Aug 2017 11:56:01 -0500 Subject: [petsc-users] help me to solve 6-dim PDE with PETSc with advice In-Reply-To: References: <8ee93603-a928-52a4-2127-a647952ea116@mail.usask.ca> <63900532-C627-445F-BFAB-2943D385174E@mcs.anl.gov> <2ac0e117-9f4d-f93e-d768-69e2019d8972@mail.usask.ca> <7bb63e5e-d724-2079-add7-591e35084fa1@mail.usask.ca> <6f48bcf7-2120-0c61-e729-c05ca1c6e546@mail.usask.ca> Message-ID: <6F9F36AC-85EA-4BEB-8BFE-BDF70087859C@mcs.anl.gov> > On Aug 1, 2017, at 11:43 AM, Oleksandr Koshkarov wrote: > >> So you are saying that E and B don't have any coupling between values at different velocities and hence don't need ghost points? > Yes, exactly - E and B depend only on space coordinates. I didn't understand this. This is very wasteful. I have no good solution. > >> It is just an optimization and you shouldn't worry about it until you have working code. > OK, thanks, that is what I will do. > > Oleksandr Koshkarov > > > On 08/01/2017 10:35 AM, Barry Smith wrote: >>> On Aug 1, 2017, at 1:20 AM, Oleksandr Koshkarov wrote: >>> >>> Thank you, it is very helpful. >>> >>> I think there is a small problem with this approach. By storing E and B in DMDA I will communicate their values each time when I communicate ghost points. Moreover, it seems that each processor will have multiples copies of E and B (depending on how big velocity range it holds). So it seems it is possible to reduce communication and memory usage by 3 (maybe it is not a big number) if each process holds only one copy of E and B. However, if E and B will be stored in local vector, it is not obvious for me how to construct a time solver so it also evolves E and B all together with C. >>> >> So you are saying that E and B don't have any coupling between values at different velocities and hence don't need ghost points? DMDA is simple, it doesn't have support for only have ghost points for some variables but should the communication prove to be time-consuming we could provide a custom version that does not ghost-point the E and B. It is just an optimization and you shouldn't worry about it until you have working code. >> >> Barry >> >> >>> p.s. currently, I am still playing with PETSc manual and I started implementing the approach you proposed. >>> >>> Best regards, >>> >>> Oleksandr Koshkarov. >>> >>> >>> On 07/30/2017 04:35 PM, Barry Smith wrote: >>>>> On Jul 30, 2017, at 2:04 PM, Oleksandr Koshkarov wrote: >>>>> >>>>> Yes, It seems I am wrong and you are right. >>>>> >>>>> I think I can then make electric and magnetic fields local and do parallel partitioning only in v space - it will defiantly restrict the problem size, but maybe the code still be still useful and I get petsc experience with it :) The question here if I will just parallize along v-space, the 3d DMDA should be enough, right? I do not really understand how would I do the partitioning here, can you please give me some hints? >>>> You could do this, it is tempting due to its simplicity. Let Mv,Nv, and Pv represent the number of grid points in the three velocity directions and Mx, Nx, Px represent the number of grid points in physical space. If you have three unknowns at each grid point represented by C, E, B then you would define >>>> >>>> dof = 3*Mx*Nx*Px >>>> >>>> Create your DMDACreate3d() using Mv,Nv, and Pv and dof then each process will have a certain number of velocity "grid" points and at each grid point there will room for all the physical points (times 3 for each unknown). So think of it as a three dimensional array with all the dependence on spatial grid point variables stacked up on top of each other. If you call >>>> >>>> DMDAVecGetArray() >>>> >>>> the resulting array will be indexed as >>>> >>>> array[kv][jv][iv][ilocal] >>>> >>>> where kv is the third grid component of velocity etc and ilocal goes from 0 to 3*Mx*Nx*Px. You can decide if you want to store the C, E, B interlaced (meaning array[kv][jv][iv][0] is the first C, array[kv][jv][iv][1] is the first E ...) or uninterlaced (meaning array[kv][jv][iv][0:Mx*Nx*Px] are the C etc). If you use noninterlaced then applying a 3d FFT to a particular component is straightforward since they are all stored next to each other. >>>> >>>> This is definitely not a scalable approach but you might be able to have Mx = My = Mz = 128 which is not bad for a spectral method. >>>> >>>> I recommend starting by writing a simple code that does this first with 2d spatial and 2d, it is just so much easy to reason about a two array as you get the kinks out of the code. >>>> >>>> Barry >>>> >>>> >>>> >>>> >>>> >>>>> Another approach is to abandon global Fourier, let say for education purposes I will pick some finite difference along spacial dimensions, how would you advice me to partition this problem with PETSc then? >>>>> >>>>> >>>>> I know something like spectral elements or discontinuous Galerkin will be ideal, but I want to get petsc experience first with simpler problem and then move to discontinuous Galerkin (this will be defiantly the next step). (Unfortunately, I have never done any unstructured meshes like spectral elements or discontinuous Galerkin myself before, but did some finite difference and spectral methods) >>>>> >>>>> On 07/30/2017 12:46 PM, Matthew Knepley wrote: >>>>>> On Sun, Jul 30, 2017 at 12:44 PM, Oleksandr Koshkarov wrote: >>>>>> Thanks for the references, and warning. >>>>>> >>>>>> I am trying to do exactly this >>>>>> http://www.sciencedirect.com/science/article/pii/S0021999115004738 >>>>>> >>>>>> (I probably should have added the reference in the first place, sorry) >>>>>> >>>>>> the evolution formula is (15) in the article. >>>>>> >>>>>> So, I will do convolution only in 3D (while full system is 6D) because velocity space is not discretized with Fourier >>>>>> >>>>>> So As I understand, it will not be N^2 vs N logN. Moreover, I know that algorithm with FFT has significantly larger "constant". >>>>>> >>>>>> Please correct me if I am wrong here :) >>>>>> >>>>>> I think you are wrong here. First, I do not understand why you think the asymptotics have changed. Second, the constant for >>>>>> FFT is about 6, which would be really hard to beat with a quadrature. >>>>>> >>>>>> Last, this discretization looks fully coupled to me. I cannot see how you would parallelize this right off the bat. This is a problem >>>>>> with spectral discretizations, and the main motivator for spectral elements. >>>>>> >>>>>> Thanks, >>>>>> >>>>>> Matt >>>>>> I know for sure that FFT is a must at the end, but I thought I can start with matrix product to get more familiar with PETSc as it will be simpler to implement (At least I think so). >>>>>> >>>>>> I hope it does make sense. >>>>>> >>>>>> Another question about convolution via matrix product. Is there better way to do it other then to construct NxN Toeplitz-like matrix each time step on the "fly" from state vector and then multiply it to state vector? >>>>>> >>>>>> p.s. Probably I should do FFT from the start, but I am a little bit intimidated by the problem taking into account that I do not have PETSc experience. >>>>>> Best regards, >>>>>> Oleksandr Koshkarov. >>>>>> >>>>>> On 07/30/2017 09:01 AM, Matthew Knepley wrote: >>>>>>> On Sat, Jul 29, 2017 at 7:01 PM, Oleksandr Koshkarov wrote: >>>>>>> Thank you for the response, >>>>>>> >>>>>>> Now that you said about additional communication for fft, I want to ask another question: >>>>>>> >>>>>>> What if I disregard FFT and will compute convolution directly, I will rewrite it as vector-matrix-vector product >>>>>>> >>>>>>> I would caution you here. The algorithm is the most important thing to get right up front. In this case, the effect of >>>>>>> dimension will be dominant, and anything that does not scale well with dimension will be thrown away, perhaps >>>>>>> quite quickly, as you want to solve bigger problems. >>>>>>> >>>>>>> Small calculation: Take a 6-dim box which is 'n' on a side, so that N = n^6. FFT is N log N, whereas direct evaluation of >>>>>>> a convolution is N^2. So if we could do n = 100 points on a side with FFT, you can do, assuming the constants are about >>>>>>> equal, >>>>>>> >>>>>>> 100^6 (log 100^6) = x^12 >>>>>>> 1e12 (6 2) = x^12 >>>>>>> x ~ 10 >>>>>>> >>>>>>> Past versions of PETSc had a higher dimensional DA construct (adda in prior versions), but no one used it so we removed it. >>>>>>> >>>>>>> I assume you are proposing something like >>>>>>> >>>>>>> https://arxiv.org/abs/1306.4625 >>>>>>> >>>>>>> or maybe >>>>>>> >>>>>>> https://arxiv.org/abs/1610.00397 >>>>>>> >>>>>>> The later is interesting since I think you could use a DMDA for the velocity and something like DMPlex for the space. >>>>>>> >>>>>>> Thanks, >>>>>>> >>>>>>> Matt >>>>>>> >>>>>>> x^T A x (where T - is transpose, x - is my state vector, and A is a matrix which represents convolution and probably it will be not very sparse). >>>>>>> >>>>>>> Yes - I will do more work (alghorithm will be slower), but will I win if we take the parallelization into account - less communication + probably more scalable algorithm? >>>>>>> >>>>>>> Best regards, >>>>>>> >>>>>>> Alex. >>>>>>> >>>>>>> >>>>>>> >>>>>>> On 07/29/2017 05:23 PM, Barry Smith wrote: >>>>>>> DMDA provides a simple way to do domain decomposition of structured grid meshes in the x, y, and z direction, that is it makes it easy to efficiently chop up vectors in all 3 dimensions, allowing very large problems easily. Unfortunately it only goes up to 3 dimensions and attempts to produce versions for higher dimensions have failed. >>>>>>> >>>>>>> If you would like to do domain decomposition across all six of your dimensions (which I think you really need to do to solve large problems) we don't have a tool that helps with doing the domain decomposition. To make matters more complicated, likely the 3d mpi-fftw that need to be applied require rejiggering the data across the nodes to get it into a form where the ffts can be applied efficiently. >>>>>>> >>>>>>> I don't think there is necessarily anything theoretically difficult about managing the six dimensional domain decomposition I just don't know of any open source software out there that helps to do this. Maybe some PETSc users are aware of such software and can chime in. >>>>>>> >>>>>>> Aside from these two issues :-) PETSc would be useful for you since you could use our time integrators and nonlinear solvers. Pulling out subvectors to process on can be done with with either VecScatter or VecStrideScatter, VecStrideGather etc depending on the layout of the unknowns, i.e. how the domain decomposition is done. >>>>>>> >>>>>>> I wish I had better answers for managing the 6d domain decomposition >>>>>>> >>>>>>> Barry >>>>>>> >>>>>>> >>>>>>> >>>>>>> >>>>>>> On Jul 29, 2017, at 5:06 PM, Oleksandr Koshkarov wrote: >>>>>>> >>>>>>> Dear All, >>>>>>> >>>>>>> I am a new PETSc user and I am still in the middle of the manual (I have finally settled to choose PETSc as my main numerical library) so I am sorry beforehand if my questions would be naive. >>>>>>> >>>>>>> I am trying to solve 6+1 dimensional Vlasov equation with spectral methods. More precisely, I will try to solve half-discretized equations of the form (approximate form) with pseudospectral Fourier method: >>>>>>> >>>>>>> (Equations are in latex format, the nice website to see them is https://www.codecogs.com/latex/eqneditor.php) >>>>>>> >>>>>>> \frac{dC_{m,m,p}}{dt} =\\ >>>>>>> \partial_x \left ( a_n C_{n+1,m,p} +b_n C_{n,m,p} +c_n C_{n-1,m,p} \right ) \\ >>>>>>> + \partial_y \left ( a_m C_{n,m+1,p} +b_m C_{n,m,p} +c_m C_{n,m-1,p} \right ) \\ >>>>>>> + \partial_z \left ( a_p C_{n,m,p+1} +b_p C_{n,m,p} +c_p C_{n,m,p-1} \right ) \\ >>>>>>> + d_n E_x C_{n-1,m,p} + d_m E_x C_{n,m-1,p} + d_p E_x C_{n,m,p-1} \\ >>>>>>> + B_x (e_{m,p} C_{n,m-1,p-1} + f_{m,p}C_{n,m-1,p+1} + \dots) + B_y (\dots) + B_z (\dots) >>>>>>> >>>>>>> >>>>>>> where a,b,c,d,e,f are some constants which can depend on n,m,p, >>>>>>> >>>>>>> n,m,p = 0...N, >>>>>>> >>>>>>> C_{n,m,p} = C_{n,m,p}(x,y,z), >>>>>>> >>>>>>> E_x = E_x(x,y,z), (same for E_y,B_x,...) >>>>>>> >>>>>>> and fields are described with equation of the sort (linear pdes with source terms dependent on C): >>>>>>> >>>>>>> \frac{dE_x}{dt} = \partial_y B_z - \partial_z B_x + (AC_{1,0,0} + BC_{0,0,0}) \\ >>>>>>> \frac{dB_x}{dt} = -\partial_y E_z + \partial_z E_x >>>>>>> >>>>>>> with A,B being some constants. >>>>>>> >>>>>>> I will need fully implicit Crank?Nicolson method, so my plan is to use SNES or TS where >>>>>>> >>>>>>> I will use one MPI PETSc vector which describes the state of the system (all, C, E, B), then I can evolve linear part with just matrix multiplication. >>>>>>> >>>>>>> The first question is, should I use something like DMDA? if so, it is only 3dimensional but I need 6 dimensional vectots? Will it be faster then matrix multiplication? >>>>>>> >>>>>>> Then to do nonlinear part I will need 3d mpi-fftw to compute convolutions. The problem is, how do I extract subvectors from full big vector state? (what is the best approach?) >>>>>>> >>>>>>> If you have some other suggestions, please feel free to share >>>>>>> >>>>>>> Thanks and best regards, >>>>>>> >>>>>>> Oleksandr Koshkarov. >>>>>>> >>>>>>> >>>>>>> >>>>>>> >>>>>>> >>>>>>> -- >>>>>>> What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. >>>>>>> -- Norbert Wiener >>>>>>> >>>>>>> http://www.caam.rice.edu/~mk51/ >>>>>> >>>>>> >>>>>> -- >>>>>> What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. >>>>>> -- Norbert Wiener >>>>>> >>>>>> http://www.caam.rice.edu/~mk51/ > From olk548 at mail.usask.ca Tue Aug 1 12:50:53 2017 From: olk548 at mail.usask.ca (Oleksandr Koshkarov) Date: Tue, 1 Aug 2017 11:50:53 -0600 Subject: [petsc-users] help me to solve 6-dim PDE with PETSc with advice In-Reply-To: <6F9F36AC-85EA-4BEB-8BFE-BDF70087859C@mcs.anl.gov> References: <8ee93603-a928-52a4-2127-a647952ea116@mail.usask.ca> <63900532-C627-445F-BFAB-2943D385174E@mcs.anl.gov> <2ac0e117-9f4d-f93e-d768-69e2019d8972@mail.usask.ca> <7bb63e5e-d724-2079-add7-591e35084fa1@mail.usask.ca> <6f48bcf7-2120-0c61-e729-c05ca1c6e546@mail.usask.ca> <6F9F36AC-85EA-4BEB-8BFE-BDF70087859C@mcs.anl.gov> Message-ID: <402b7ee7-957f-1149-2658-af5a24a035c6@mail.usask.ca> > I didn't understand this. This is very wasteful. I have no good solution. Equations for E and B are linear, moreover I know exactly which time solver I need - implicit Crank?Nicolson method, which conserves energy exactly in my case - and I know it works well from the article. So instead of PETSc TS, I can use SNES and do the time discretization myself. Therefore inside SNES, I will solve local linear system for E^{n+1} and B^{n+1} each time. And each processor will store only one copy of local E^{n} and B^{n}. It will probably even improve the convergence of overall nonlinear solver. Does it make sense? Oleksandr Koshkarov. On 08/01/2017 10:56 AM, Barry Smith wrote: >> On Aug 1, 2017, at 11:43 AM, Oleksandr Koshkarov wrote: >> >>> So you are saying that E and B don't have any coupling between values at different velocities and hence don't need ghost points? >> Yes, exactly - E and B depend only on space coordinates. > I didn't understand this. This is very wasteful. I have no good solution. >>> It is just an optimization and you shouldn't worry about it until you have working code. >> OK, thanks, that is what I will do. >> >> Oleksandr Koshkarov >> >> >> On 08/01/2017 10:35 AM, Barry Smith wrote: >>>> On Aug 1, 2017, at 1:20 AM, Oleksandr Koshkarov wrote: >>>> >>>> Thank you, it is very helpful. >>>> >>>> I think there is a small problem with this approach. By storing E and B in DMDA I will communicate their values each time when I communicate ghost points. Moreover, it seems that each processor will have multiples copies of E and B (depending on how big velocity range it holds). So it seems it is possible to reduce communication and memory usage by 3 (maybe it is not a big number) if each process holds only one copy of E and B. However, if E and B will be stored in local vector, it is not obvious for me how to construct a time solver so it also evolves E and B all together with C. >>>> >>> So you are saying that E and B don't have any coupling between values at different velocities and hence don't need ghost points? DMDA is simple, it doesn't have support for only have ghost points for some variables but should the communication prove to be time-consuming we could provide a custom version that does not ghost-point the E and B. It is just an optimization and you shouldn't worry about it until you have working code. >>> >>> Barry >>> >>> >>>> p.s. currently, I am still playing with PETSc manual and I started implementing the approach you proposed. >>>> >>>> Best regards, >>>> >>>> Oleksandr Koshkarov. >>>> >>>> >>>> On 07/30/2017 04:35 PM, Barry Smith wrote: >>>>>> On Jul 30, 2017, at 2:04 PM, Oleksandr Koshkarov wrote: >>>>>> >>>>>> Yes, It seems I am wrong and you are right. >>>>>> >>>>>> I think I can then make electric and magnetic fields local and do parallel partitioning only in v space - it will defiantly restrict the problem size, but maybe the code still be still useful and I get petsc experience with it :) The question here if I will just parallize along v-space, the 3d DMDA should be enough, right? I do not really understand how would I do the partitioning here, can you please give me some hints? >>>>> You could do this, it is tempting due to its simplicity. Let Mv,Nv, and Pv represent the number of grid points in the three velocity directions and Mx, Nx, Px represent the number of grid points in physical space. If you have three unknowns at each grid point represented by C, E, B then you would define >>>>> >>>>> dof = 3*Mx*Nx*Px >>>>> >>>>> Create your DMDACreate3d() using Mv,Nv, and Pv and dof then each process will have a certain number of velocity "grid" points and at each grid point there will room for all the physical points (times 3 for each unknown). So think of it as a three dimensional array with all the dependence on spatial grid point variables stacked up on top of each other. If you call >>>>> >>>>> DMDAVecGetArray() >>>>> >>>>> the resulting array will be indexed as >>>>> >>>>> array[kv][jv][iv][ilocal] >>>>> >>>>> where kv is the third grid component of velocity etc and ilocal goes from 0 to 3*Mx*Nx*Px. You can decide if you want to store the C, E, B interlaced (meaning array[kv][jv][iv][0] is the first C, array[kv][jv][iv][1] is the first E ...) or uninterlaced (meaning array[kv][jv][iv][0:Mx*Nx*Px] are the C etc). If you use noninterlaced then applying a 3d FFT to a particular component is straightforward since they are all stored next to each other. >>>>> >>>>> This is definitely not a scalable approach but you might be able to have Mx = My = Mz = 128 which is not bad for a spectral method. >>>>> >>>>> I recommend starting by writing a simple code that does this first with 2d spatial and 2d, it is just so much easy to reason about a two array as you get the kinks out of the code. >>>>> >>>>> Barry >>>>> >>>>> >>>>> >>>>> >>>>> >>>>>> Another approach is to abandon global Fourier, let say for education purposes I will pick some finite difference along spacial dimensions, how would you advice me to partition this problem with PETSc then? >>>>>> >>>>>> >>>>>> I know something like spectral elements or discontinuous Galerkin will be ideal, but I want to get petsc experience first with simpler problem and then move to discontinuous Galerkin (this will be defiantly the next step). (Unfortunately, I have never done any unstructured meshes like spectral elements or discontinuous Galerkin myself before, but did some finite difference and spectral methods) >>>>>> >>>>>> On 07/30/2017 12:46 PM, Matthew Knepley wrote: >>>>>>> On Sun, Jul 30, 2017 at 12:44 PM, Oleksandr Koshkarov wrote: >>>>>>> Thanks for the references, and warning. >>>>>>> >>>>>>> I am trying to do exactly this >>>>>>> http://www.sciencedirect.com/science/article/pii/S0021999115004738 >>>>>>> >>>>>>> (I probably should have added the reference in the first place, sorry) >>>>>>> >>>>>>> the evolution formula is (15) in the article. >>>>>>> >>>>>>> So, I will do convolution only in 3D (while full system is 6D) because velocity space is not discretized with Fourier >>>>>>> >>>>>>> So As I understand, it will not be N^2 vs N logN. Moreover, I know that algorithm with FFT has significantly larger "constant". >>>>>>> >>>>>>> Please correct me if I am wrong here :) >>>>>>> >>>>>>> I think you are wrong here. First, I do not understand why you think the asymptotics have changed. Second, the constant for >>>>>>> FFT is about 6, which would be really hard to beat with a quadrature. >>>>>>> >>>>>>> Last, this discretization looks fully coupled to me. I cannot see how you would parallelize this right off the bat. This is a problem >>>>>>> with spectral discretizations, and the main motivator for spectral elements. >>>>>>> >>>>>>> Thanks, >>>>>>> >>>>>>> Matt >>>>>>> I know for sure that FFT is a must at the end, but I thought I can start with matrix product to get more familiar with PETSc as it will be simpler to implement (At least I think so). >>>>>>> >>>>>>> I hope it does make sense. >>>>>>> >>>>>>> Another question about convolution via matrix product. Is there better way to do it other then to construct NxN Toeplitz-like matrix each time step on the "fly" from state vector and then multiply it to state vector? >>>>>>> >>>>>>> p.s. Probably I should do FFT from the start, but I am a little bit intimidated by the problem taking into account that I do not have PETSc experience. >>>>>>> Best regards, >>>>>>> Oleksandr Koshkarov. >>>>>>> >>>>>>> On 07/30/2017 09:01 AM, Matthew Knepley wrote: >>>>>>>> On Sat, Jul 29, 2017 at 7:01 PM, Oleksandr Koshkarov wrote: >>>>>>>> Thank you for the response, >>>>>>>> >>>>>>>> Now that you said about additional communication for fft, I want to ask another question: >>>>>>>> >>>>>>>> What if I disregard FFT and will compute convolution directly, I will rewrite it as vector-matrix-vector product >>>>>>>> >>>>>>>> I would caution you here. The algorithm is the most important thing to get right up front. In this case, the effect of >>>>>>>> dimension will be dominant, and anything that does not scale well with dimension will be thrown away, perhaps >>>>>>>> quite quickly, as you want to solve bigger problems. >>>>>>>> >>>>>>>> Small calculation: Take a 6-dim box which is 'n' on a side, so that N = n^6. FFT is N log N, whereas direct evaluation of >>>>>>>> a convolution is N^2. So if we could do n = 100 points on a side with FFT, you can do, assuming the constants are about >>>>>>>> equal, >>>>>>>> >>>>>>>> 100^6 (log 100^6) = x^12 >>>>>>>> 1e12 (6 2) = x^12 >>>>>>>> x ~ 10 >>>>>>>> >>>>>>>> Past versions of PETSc had a higher dimensional DA construct (adda in prior versions), but no one used it so we removed it. >>>>>>>> >>>>>>>> I assume you are proposing something like >>>>>>>> >>>>>>>> https://arxiv.org/abs/1306.4625 >>>>>>>> >>>>>>>> or maybe >>>>>>>> >>>>>>>> https://arxiv.org/abs/1610.00397 >>>>>>>> >>>>>>>> The later is interesting since I think you could use a DMDA for the velocity and something like DMPlex for the space. >>>>>>>> >>>>>>>> Thanks, >>>>>>>> >>>>>>>> Matt >>>>>>>> >>>>>>>> x^T A x (where T - is transpose, x - is my state vector, and A is a matrix which represents convolution and probably it will be not very sparse). >>>>>>>> >>>>>>>> Yes - I will do more work (alghorithm will be slower), but will I win if we take the parallelization into account - less communication + probably more scalable algorithm? >>>>>>>> >>>>>>>> Best regards, >>>>>>>> >>>>>>>> Alex. >>>>>>>> >>>>>>>> >>>>>>>> >>>>>>>> On 07/29/2017 05:23 PM, Barry Smith wrote: >>>>>>>> DMDA provides a simple way to do domain decomposition of structured grid meshes in the x, y, and z direction, that is it makes it easy to efficiently chop up vectors in all 3 dimensions, allowing very large problems easily. Unfortunately it only goes up to 3 dimensions and attempts to produce versions for higher dimensions have failed. >>>>>>>> >>>>>>>> If you would like to do domain decomposition across all six of your dimensions (which I think you really need to do to solve large problems) we don't have a tool that helps with doing the domain decomposition. To make matters more complicated, likely the 3d mpi-fftw that need to be applied require rejiggering the data across the nodes to get it into a form where the ffts can be applied efficiently. >>>>>>>> >>>>>>>> I don't think there is necessarily anything theoretically difficult about managing the six dimensional domain decomposition I just don't know of any open source software out there that helps to do this. Maybe some PETSc users are aware of such software and can chime in. >>>>>>>> >>>>>>>> Aside from these two issues :-) PETSc would be useful for you since you could use our time integrators and nonlinear solvers. Pulling out subvectors to process on can be done with with either VecScatter or VecStrideScatter, VecStrideGather etc depending on the layout of the unknowns, i.e. how the domain decomposition is done. >>>>>>>> >>>>>>>> I wish I had better answers for managing the 6d domain decomposition >>>>>>>> >>>>>>>> Barry >>>>>>>> >>>>>>>> >>>>>>>> >>>>>>>> >>>>>>>> On Jul 29, 2017, at 5:06 PM, Oleksandr Koshkarov wrote: >>>>>>>> >>>>>>>> Dear All, >>>>>>>> >>>>>>>> I am a new PETSc user and I am still in the middle of the manual (I have finally settled to choose PETSc as my main numerical library) so I am sorry beforehand if my questions would be naive. >>>>>>>> >>>>>>>> I am trying to solve 6+1 dimensional Vlasov equation with spectral methods. More precisely, I will try to solve half-discretized equations of the form (approximate form) with pseudospectral Fourier method: >>>>>>>> >>>>>>>> (Equations are in latex format, the nice website to see them is https://www.codecogs.com/latex/eqneditor.php) >>>>>>>> >>>>>>>> \frac{dC_{m,m,p}}{dt} =\\ >>>>>>>> \partial_x \left ( a_n C_{n+1,m,p} +b_n C_{n,m,p} +c_n C_{n-1,m,p} \right ) \\ >>>>>>>> + \partial_y \left ( a_m C_{n,m+1,p} +b_m C_{n,m,p} +c_m C_{n,m-1,p} \right ) \\ >>>>>>>> + \partial_z \left ( a_p C_{n,m,p+1} +b_p C_{n,m,p} +c_p C_{n,m,p-1} \right ) \\ >>>>>>>> + d_n E_x C_{n-1,m,p} + d_m E_x C_{n,m-1,p} + d_p E_x C_{n,m,p-1} \\ >>>>>>>> + B_x (e_{m,p} C_{n,m-1,p-1} + f_{m,p}C_{n,m-1,p+1} + \dots) + B_y (\dots) + B_z (\dots) >>>>>>>> >>>>>>>> >>>>>>>> where a,b,c,d,e,f are some constants which can depend on n,m,p, >>>>>>>> >>>>>>>> n,m,p = 0...N, >>>>>>>> >>>>>>>> C_{n,m,p} = C_{n,m,p}(x,y,z), >>>>>>>> >>>>>>>> E_x = E_x(x,y,z), (same for E_y,B_x,...) >>>>>>>> >>>>>>>> and fields are described with equation of the sort (linear pdes with source terms dependent on C): >>>>>>>> >>>>>>>> \frac{dE_x}{dt} = \partial_y B_z - \partial_z B_x + (AC_{1,0,0} + BC_{0,0,0}) \\ >>>>>>>> \frac{dB_x}{dt} = -\partial_y E_z + \partial_z E_x >>>>>>>> >>>>>>>> with A,B being some constants. >>>>>>>> >>>>>>>> I will need fully implicit Crank?Nicolson method, so my plan is to use SNES or TS where >>>>>>>> >>>>>>>> I will use one MPI PETSc vector which describes the state of the system (all, C, E, B), then I can evolve linear part with just matrix multiplication. >>>>>>>> >>>>>>>> The first question is, should I use something like DMDA? if so, it is only 3dimensional but I need 6 dimensional vectots? Will it be faster then matrix multiplication? >>>>>>>> >>>>>>>> Then to do nonlinear part I will need 3d mpi-fftw to compute convolutions. The problem is, how do I extract subvectors from full big vector state? (what is the best approach?) >>>>>>>> >>>>>>>> If you have some other suggestions, please feel free to share >>>>>>>> >>>>>>>> Thanks and best regards, >>>>>>>> >>>>>>>> Oleksandr Koshkarov. >>>>>>>> >>>>>>>> >>>>>>>> >>>>>>>> >>>>>>>> >>>>>>>> -- >>>>>>>> What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. >>>>>>>> -- Norbert Wiener >>>>>>>> >>>>>>>> http://www.caam.rice.edu/~mk51/ >>>>>>> >>>>>>> -- >>>>>>> What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. >>>>>>> -- Norbert Wiener >>>>>>> >>>>>>> http://www.caam.rice.edu/~mk51/ From bsmith at mcs.anl.gov Tue Aug 1 12:56:32 2017 From: bsmith at mcs.anl.gov (Barry Smith) Date: Tue, 1 Aug 2017 12:56:32 -0500 Subject: [petsc-users] help me to solve 6-dim PDE with PETSc with advice In-Reply-To: <402b7ee7-957f-1149-2658-af5a24a035c6@mail.usask.ca> References: <8ee93603-a928-52a4-2127-a647952ea116@mail.usask.ca> <63900532-C627-445F-BFAB-2943D385174E@mcs.anl.gov> <2ac0e117-9f4d-f93e-d768-69e2019d8972@mail.usask.ca> <7bb63e5e-d724-2079-add7-591e35084fa1@mail.usask.ca> <6f48bcf7-2120-0c61-e729-c05ca1c6e546@mail.usask.ca> <6F9F36AC-85EA-4BEB-8BFE-BDF70087859C@mcs.anl.gov> <402b7ee7-957f-1149-2658-af5a24a035c6@mail.usask.ca> Message-ID: <7EC360BA-4E0F-4213-B8F1-9F8F915A3D9D@mcs.anl.gov> > On Aug 1, 2017, at 12:50 PM, Oleksandr Koshkarov wrote: > >> I didn't understand this. This is very wasteful. I have no good solution. > Equations for E and B are linear, moreover I know exactly which time solver I need - implicit Crank?Nicolson method, which conserves energy exactly in my case - and I know it works well from the article. So instead of PETSc TS, I can use SNES and do the time discretization myself. Therefore inside SNES, I will solve local linear system for E^{n+1} and B^{n+1} each time. > > And each processor will store only one copy of local E^{n} and B^{n}. > > It will probably even improve the convergence of overall nonlinear solver. > > Does it make sense? I am not completely clear. You cannot have the E and B associated with the DMDA so the DMDA dof would be 1*Mx*Nx*Px and you'd keep the E and B in some other vectors? Barry > > Oleksandr Koshkarov. > > > On 08/01/2017 10:56 AM, Barry Smith wrote: >>> On Aug 1, 2017, at 11:43 AM, Oleksandr Koshkarov wrote: >>> >>>> So you are saying that E and B don't have any coupling between values at different velocities and hence don't need ghost points? >>> Yes, exactly - E and B depend only on space coordinates. >> I didn't understand this. This is very wasteful. I have no good solution. >>>> It is just an optimization and you shouldn't worry about it until you have working code. >>> OK, thanks, that is what I will do. >>> >>> Oleksandr Koshkarov >>> >>> >>> On 08/01/2017 10:35 AM, Barry Smith wrote: >>>>> On Aug 1, 2017, at 1:20 AM, Oleksandr Koshkarov wrote: >>>>> >>>>> Thank you, it is very helpful. >>>>> >>>>> I think there is a small problem with this approach. By storing E and B in DMDA I will communicate their values each time when I communicate ghost points. Moreover, it seems that each processor will have multiples copies of E and B (depending on how big velocity range it holds). So it seems it is possible to reduce communication and memory usage by 3 (maybe it is not a big number) if each process holds only one copy of E and B. However, if E and B will be stored in local vector, it is not obvious for me how to construct a time solver so it also evolves E and B all together with C. >>>>> >>>> So you are saying that E and B don't have any coupling between values at different velocities and hence don't need ghost points? DMDA is simple, it doesn't have support for only have ghost points for some variables but should the communication prove to be time-consuming we could provide a custom version that does not ghost-point the E and B. It is just an optimization and you shouldn't worry about it until you have working code. >>>> >>>> Barry >>>> >>>> >>>>> p.s. currently, I am still playing with PETSc manual and I started implementing the approach you proposed. >>>>> >>>>> Best regards, >>>>> >>>>> Oleksandr Koshkarov. >>>>> >>>>> >>>>> On 07/30/2017 04:35 PM, Barry Smith wrote: >>>>>>> On Jul 30, 2017, at 2:04 PM, Oleksandr Koshkarov wrote: >>>>>>> >>>>>>> Yes, It seems I am wrong and you are right. >>>>>>> >>>>>>> I think I can then make electric and magnetic fields local and do parallel partitioning only in v space - it will defiantly restrict the problem size, but maybe the code still be still useful and I get petsc experience with it :) The question here if I will just parallize along v-space, the 3d DMDA should be enough, right? I do not really understand how would I do the partitioning here, can you please give me some hints? >>>>>> You could do this, it is tempting due to its simplicity. Let Mv,Nv, and Pv represent the number of grid points in the three velocity directions and Mx, Nx, Px represent the number of grid points in physical space. If you have three unknowns at each grid point represented by C, E, B then you would define >>>>>> >>>>>> dof = 3*Mx*Nx*Px >>>>>> >>>>>> Create your DMDACreate3d() using Mv,Nv, and Pv and dof then each process will have a certain number of velocity "grid" points and at each grid point there will room for all the physical points (times 3 for each unknown). So think of it as a three dimensional array with all the dependence on spatial grid point variables stacked up on top of each other. If you call >>>>>> >>>>>> DMDAVecGetArray() >>>>>> >>>>>> the resulting array will be indexed as >>>>>> >>>>>> array[kv][jv][iv][ilocal] >>>>>> >>>>>> where kv is the third grid component of velocity etc and ilocal goes from 0 to 3*Mx*Nx*Px. You can decide if you want to store the C, E, B interlaced (meaning array[kv][jv][iv][0] is the first C, array[kv][jv][iv][1] is the first E ...) or uninterlaced (meaning array[kv][jv][iv][0:Mx*Nx*Px] are the C etc). If you use noninterlaced then applying a 3d FFT to a particular component is straightforward since they are all stored next to each other. >>>>>> >>>>>> This is definitely not a scalable approach but you might be able to have Mx = My = Mz = 128 which is not bad for a spectral method. >>>>>> >>>>>> I recommend starting by writing a simple code that does this first with 2d spatial and 2d, it is just so much easy to reason about a two array as you get the kinks out of the code. >>>>>> >>>>>> Barry >>>>>> >>>>>> >>>>>> >>>>>> >>>>>> >>>>>>> Another approach is to abandon global Fourier, let say for education purposes I will pick some finite difference along spacial dimensions, how would you advice me to partition this problem with PETSc then? >>>>>>> >>>>>>> >>>>>>> I know something like spectral elements or discontinuous Galerkin will be ideal, but I want to get petsc experience first with simpler problem and then move to discontinuous Galerkin (this will be defiantly the next step). (Unfortunately, I have never done any unstructured meshes like spectral elements or discontinuous Galerkin myself before, but did some finite difference and spectral methods) >>>>>>> >>>>>>> On 07/30/2017 12:46 PM, Matthew Knepley wrote: >>>>>>>> On Sun, Jul 30, 2017 at 12:44 PM, Oleksandr Koshkarov wrote: >>>>>>>> Thanks for the references, and warning. >>>>>>>> >>>>>>>> I am trying to do exactly this >>>>>>>> http://www.sciencedirect.com/science/article/pii/S0021999115004738 >>>>>>>> >>>>>>>> (I probably should have added the reference in the first place, sorry) >>>>>>>> >>>>>>>> the evolution formula is (15) in the article. >>>>>>>> >>>>>>>> So, I will do convolution only in 3D (while full system is 6D) because velocity space is not discretized with Fourier >>>>>>>> >>>>>>>> So As I understand, it will not be N^2 vs N logN. Moreover, I know that algorithm with FFT has significantly larger "constant". >>>>>>>> >>>>>>>> Please correct me if I am wrong here :) >>>>>>>> >>>>>>>> I think you are wrong here. First, I do not understand why you think the asymptotics have changed. Second, the constant for >>>>>>>> FFT is about 6, which would be really hard to beat with a quadrature. >>>>>>>> >>>>>>>> Last, this discretization looks fully coupled to me. I cannot see how you would parallelize this right off the bat. This is a problem >>>>>>>> with spectral discretizations, and the main motivator for spectral elements. >>>>>>>> >>>>>>>> Thanks, >>>>>>>> >>>>>>>> Matt >>>>>>>> I know for sure that FFT is a must at the end, but I thought I can start with matrix product to get more familiar with PETSc as it will be simpler to implement (At least I think so). >>>>>>>> >>>>>>>> I hope it does make sense. >>>>>>>> >>>>>>>> Another question about convolution via matrix product. Is there better way to do it other then to construct NxN Toeplitz-like matrix each time step on the "fly" from state vector and then multiply it to state vector? >>>>>>>> >>>>>>>> p.s. Probably I should do FFT from the start, but I am a little bit intimidated by the problem taking into account that I do not have PETSc experience. >>>>>>>> Best regards, >>>>>>>> Oleksandr Koshkarov. >>>>>>>> >>>>>>>> On 07/30/2017 09:01 AM, Matthew Knepley wrote: >>>>>>>>> On Sat, Jul 29, 2017 at 7:01 PM, Oleksandr Koshkarov wrote: >>>>>>>>> Thank you for the response, >>>>>>>>> >>>>>>>>> Now that you said about additional communication for fft, I want to ask another question: >>>>>>>>> >>>>>>>>> What if I disregard FFT and will compute convolution directly, I will rewrite it as vector-matrix-vector product >>>>>>>>> >>>>>>>>> I would caution you here. The algorithm is the most important thing to get right up front. In this case, the effect of >>>>>>>>> dimension will be dominant, and anything that does not scale well with dimension will be thrown away, perhaps >>>>>>>>> quite quickly, as you want to solve bigger problems. >>>>>>>>> >>>>>>>>> Small calculation: Take a 6-dim box which is 'n' on a side, so that N = n^6. FFT is N log N, whereas direct evaluation of >>>>>>>>> a convolution is N^2. So if we could do n = 100 points on a side with FFT, you can do, assuming the constants are about >>>>>>>>> equal, >>>>>>>>> >>>>>>>>> 100^6 (log 100^6) = x^12 >>>>>>>>> 1e12 (6 2) = x^12 >>>>>>>>> x ~ 10 >>>>>>>>> >>>>>>>>> Past versions of PETSc had a higher dimensional DA construct (adda in prior versions), but no one used it so we removed it. >>>>>>>>> >>>>>>>>> I assume you are proposing something like >>>>>>>>> >>>>>>>>> https://arxiv.org/abs/1306.4625 >>>>>>>>> >>>>>>>>> or maybe >>>>>>>>> >>>>>>>>> https://arxiv.org/abs/1610.00397 >>>>>>>>> >>>>>>>>> The later is interesting since I think you could use a DMDA for the velocity and something like DMPlex for the space. >>>>>>>>> >>>>>>>>> Thanks, >>>>>>>>> >>>>>>>>> Matt >>>>>>>>> >>>>>>>>> x^T A x (where T - is transpose, x - is my state vector, and A is a matrix which represents convolution and probably it will be not very sparse). >>>>>>>>> >>>>>>>>> Yes - I will do more work (alghorithm will be slower), but will I win if we take the parallelization into account - less communication + probably more scalable algorithm? >>>>>>>>> >>>>>>>>> Best regards, >>>>>>>>> >>>>>>>>> Alex. >>>>>>>>> >>>>>>>>> >>>>>>>>> >>>>>>>>> On 07/29/2017 05:23 PM, Barry Smith wrote: >>>>>>>>> DMDA provides a simple way to do domain decomposition of structured grid meshes in the x, y, and z direction, that is it makes it easy to efficiently chop up vectors in all 3 dimensions, allowing very large problems easily. Unfortunately it only goes up to 3 dimensions and attempts to produce versions for higher dimensions have failed. >>>>>>>>> >>>>>>>>> If you would like to do domain decomposition across all six of your dimensions (which I think you really need to do to solve large problems) we don't have a tool that helps with doing the domain decomposition. To make matters more complicated, likely the 3d mpi-fftw that need to be applied require rejiggering the data across the nodes to get it into a form where the ffts can be applied efficiently. >>>>>>>>> >>>>>>>>> I don't think there is necessarily anything theoretically difficult about managing the six dimensional domain decomposition I just don't know of any open source software out there that helps to do this. Maybe some PETSc users are aware of such software and can chime in. >>>>>>>>> >>>>>>>>> Aside from these two issues :-) PETSc would be useful for you since you could use our time integrators and nonlinear solvers. Pulling out subvectors to process on can be done with with either VecScatter or VecStrideScatter, VecStrideGather etc depending on the layout of the unknowns, i.e. how the domain decomposition is done. >>>>>>>>> >>>>>>>>> I wish I had better answers for managing the 6d domain decomposition >>>>>>>>> >>>>>>>>> Barry >>>>>>>>> >>>>>>>>> >>>>>>>>> >>>>>>>>> >>>>>>>>> On Jul 29, 2017, at 5:06 PM, Oleksandr Koshkarov wrote: >>>>>>>>> >>>>>>>>> Dear All, >>>>>>>>> >>>>>>>>> I am a new PETSc user and I am still in the middle of the manual (I have finally settled to choose PETSc as my main numerical library) so I am sorry beforehand if my questions would be naive. >>>>>>>>> >>>>>>>>> I am trying to solve 6+1 dimensional Vlasov equation with spectral methods. More precisely, I will try to solve half-discretized equations of the form (approximate form) with pseudospectral Fourier method: >>>>>>>>> >>>>>>>>> (Equations are in latex format, the nice website to see them is https://www.codecogs.com/latex/eqneditor.php) >>>>>>>>> >>>>>>>>> \frac{dC_{m,m,p}}{dt} =\\ >>>>>>>>> \partial_x \left ( a_n C_{n+1,m,p} +b_n C_{n,m,p} +c_n C_{n-1,m,p} \right ) \\ >>>>>>>>> + \partial_y \left ( a_m C_{n,m+1,p} +b_m C_{n,m,p} +c_m C_{n,m-1,p} \right ) \\ >>>>>>>>> + \partial_z \left ( a_p C_{n,m,p+1} +b_p C_{n,m,p} +c_p C_{n,m,p-1} \right ) \\ >>>>>>>>> + d_n E_x C_{n-1,m,p} + d_m E_x C_{n,m-1,p} + d_p E_x C_{n,m,p-1} \\ >>>>>>>>> + B_x (e_{m,p} C_{n,m-1,p-1} + f_{m,p}C_{n,m-1,p+1} + \dots) + B_y (\dots) + B_z (\dots) >>>>>>>>> >>>>>>>>> >>>>>>>>> where a,b,c,d,e,f are some constants which can depend on n,m,p, >>>>>>>>> >>>>>>>>> n,m,p = 0...N, >>>>>>>>> >>>>>>>>> C_{n,m,p} = C_{n,m,p}(x,y,z), >>>>>>>>> >>>>>>>>> E_x = E_x(x,y,z), (same for E_y,B_x,...) >>>>>>>>> >>>>>>>>> and fields are described with equation of the sort (linear pdes with source terms dependent on C): >>>>>>>>> >>>>>>>>> \frac{dE_x}{dt} = \partial_y B_z - \partial_z B_x + (AC_{1,0,0} + BC_{0,0,0}) \\ >>>>>>>>> \frac{dB_x}{dt} = -\partial_y E_z + \partial_z E_x >>>>>>>>> >>>>>>>>> with A,B being some constants. >>>>>>>>> >>>>>>>>> I will need fully implicit Crank?Nicolson method, so my plan is to use SNES or TS where >>>>>>>>> >>>>>>>>> I will use one MPI PETSc vector which describes the state of the system (all, C, E, B), then I can evolve linear part with just matrix multiplication. >>>>>>>>> >>>>>>>>> The first question is, should I use something like DMDA? if so, it is only 3dimensional but I need 6 dimensional vectots? Will it be faster then matrix multiplication? >>>>>>>>> >>>>>>>>> Then to do nonlinear part I will need 3d mpi-fftw to compute convolutions. The problem is, how do I extract subvectors from full big vector state? (what is the best approach?) >>>>>>>>> >>>>>>>>> If you have some other suggestions, please feel free to share >>>>>>>>> >>>>>>>>> Thanks and best regards, >>>>>>>>> >>>>>>>>> Oleksandr Koshkarov. >>>>>>>>> >>>>>>>>> >>>>>>>>> >>>>>>>>> >>>>>>>>> >>>>>>>>> -- >>>>>>>>> What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. >>>>>>>>> -- Norbert Wiener >>>>>>>>> >>>>>>>>> http://www.caam.rice.edu/~mk51/ >>>>>>>> >>>>>>>> -- >>>>>>>> What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. >>>>>>>> -- Norbert Wiener >>>>>>>> >>>>>>>> http://www.caam.rice.edu/~mk51/ > From olk548 at mail.usask.ca Tue Aug 1 13:08:33 2017 From: olk548 at mail.usask.ca (Oleksandr Koshkarov) Date: Tue, 1 Aug 2017 12:08:33 -0600 Subject: [petsc-users] help me to solve 6-dim PDE with PETSc with advice In-Reply-To: <7EC360BA-4E0F-4213-B8F1-9F8F915A3D9D@mcs.anl.gov> References: <8ee93603-a928-52a4-2127-a647952ea116@mail.usask.ca> <63900532-C627-445F-BFAB-2943D385174E@mcs.anl.gov> <2ac0e117-9f4d-f93e-d768-69e2019d8972@mail.usask.ca> <7bb63e5e-d724-2079-add7-591e35084fa1@mail.usask.ca> <6f48bcf7-2120-0c61-e729-c05ca1c6e546@mail.usask.ca> <6F9F36AC-85EA-4BEB-8BFE-BDF70087859C@mcs.anl.gov> <402b7ee7-957f-1149-2658-af5a24a035c6@mail.usask.ca> <7EC360BA-4E0F-4213-B8F1-9F8F915A3D9D@mcs.anl.gov> Message-ID: <133ae5a6-dbe5-03d6-2a0f-d4e4da465de0@mail.usask.ca> > I am not completely clear. You cannot have the E and B associated with the DMDA so the DMDA dof would be 1*Mx*Nx*Px and you'd keep the E and B in some other vectors? Yes, I was thinking to do that - keep E and B in some local vector. and DMDA with dof=1*Mx*Nx*Px for C. Oleksandr Koshkarov. On 08/01/2017 11:56 AM, Barry Smith wrote: >> On Aug 1, 2017, at 12:50 PM, Oleksandr Koshkarov wrote: >> >>> I didn't understand this. This is very wasteful. I have no good solution. >> Equations for E and B are linear, moreover I know exactly which time solver I need - implicit Crank?Nicolson method, which conserves energy exactly in my case - and I know it works well from the article. So instead of PETSc TS, I can use SNES and do the time discretization myself. Therefore inside SNES, I will solve local linear system for E^{n+1} and B^{n+1} each time. >> >> And each processor will store only one copy of local E^{n} and B^{n}. >> >> It will probably even improve the convergence of overall nonlinear solver. >> >> Does it make sense? > I am not completely clear. You cannot have the E and B associated with the DMDA so the DMDA dof would be 1*Mx*Nx*Px and you'd keep the E and B in some other vectors? > > Barry > >> Oleksandr Koshkarov. >> >> >> On 08/01/2017 10:56 AM, Barry Smith wrote: >>>> On Aug 1, 2017, at 11:43 AM, Oleksandr Koshkarov wrote: >>>> >>>>> So you are saying that E and B don't have any coupling between values at different velocities and hence don't need ghost points? >>>> Yes, exactly - E and B depend only on space coordinates. >>> I didn't understand this. This is very wasteful. I have no good solution. >>>>> It is just an optimization and you shouldn't worry about it until you have working code. >>>> OK, thanks, that is what I will do. >>>> >>>> Oleksandr Koshkarov >>>> >>>> >>>> On 08/01/2017 10:35 AM, Barry Smith wrote: >>>>>> On Aug 1, 2017, at 1:20 AM, Oleksandr Koshkarov wrote: >>>>>> >>>>>> Thank you, it is very helpful. >>>>>> >>>>>> I think there is a small problem with this approach. By storing E and B in DMDA I will communicate their values each time when I communicate ghost points. Moreover, it seems that each processor will have multiples copies of E and B (depending on how big velocity range it holds). So it seems it is possible to reduce communication and memory usage by 3 (maybe it is not a big number) if each process holds only one copy of E and B. However, if E and B will be stored in local vector, it is not obvious for me how to construct a time solver so it also evolves E and B all together with C. >>>>>> >>>>> So you are saying that E and B don't have any coupling between values at different velocities and hence don't need ghost points? DMDA is simple, it doesn't have support for only have ghost points for some variables but should the communication prove to be time-consuming we could provide a custom version that does not ghost-point the E and B. It is just an optimization and you shouldn't worry about it until you have working code. >>>>> >>>>> Barry >>>>> >>>>> >>>>>> p.s. currently, I am still playing with PETSc manual and I started implementing the approach you proposed. >>>>>> >>>>>> Best regards, >>>>>> >>>>>> Oleksandr Koshkarov. >>>>>> >>>>>> >>>>>> On 07/30/2017 04:35 PM, Barry Smith wrote: >>>>>>>> On Jul 30, 2017, at 2:04 PM, Oleksandr Koshkarov wrote: >>>>>>>> >>>>>>>> Yes, It seems I am wrong and you are right. >>>>>>>> >>>>>>>> I think I can then make electric and magnetic fields local and do parallel partitioning only in v space - it will defiantly restrict the problem size, but maybe the code still be still useful and I get petsc experience with it :) The question here if I will just parallize along v-space, the 3d DMDA should be enough, right? I do not really understand how would I do the partitioning here, can you please give me some hints? >>>>>>> You could do this, it is tempting due to its simplicity. Let Mv,Nv, and Pv represent the number of grid points in the three velocity directions and Mx, Nx, Px represent the number of grid points in physical space. If you have three unknowns at each grid point represented by C, E, B then you would define >>>>>>> >>>>>>> dof = 3*Mx*Nx*Px >>>>>>> >>>>>>> Create your DMDACreate3d() using Mv,Nv, and Pv and dof then each process will have a certain number of velocity "grid" points and at each grid point there will room for all the physical points (times 3 for each unknown). So think of it as a three dimensional array with all the dependence on spatial grid point variables stacked up on top of each other. If you call >>>>>>> >>>>>>> DMDAVecGetArray() >>>>>>> >>>>>>> the resulting array will be indexed as >>>>>>> >>>>>>> array[kv][jv][iv][ilocal] >>>>>>> >>>>>>> where kv is the third grid component of velocity etc and ilocal goes from 0 to 3*Mx*Nx*Px. You can decide if you want to store the C, E, B interlaced (meaning array[kv][jv][iv][0] is the first C, array[kv][jv][iv][1] is the first E ...) or uninterlaced (meaning array[kv][jv][iv][0:Mx*Nx*Px] are the C etc). If you use noninterlaced then applying a 3d FFT to a particular component is straightforward since they are all stored next to each other. >>>>>>> >>>>>>> This is definitely not a scalable approach but you might be able to have Mx = My = Mz = 128 which is not bad for a spectral method. >>>>>>> >>>>>>> I recommend starting by writing a simple code that does this first with 2d spatial and 2d, it is just so much easy to reason about a two array as you get the kinks out of the code. >>>>>>> >>>>>>> Barry >>>>>>> >>>>>>> >>>>>>> >>>>>>> >>>>>>> >>>>>>>> Another approach is to abandon global Fourier, let say for education purposes I will pick some finite difference along spacial dimensions, how would you advice me to partition this problem with PETSc then? >>>>>>>> >>>>>>>> >>>>>>>> I know something like spectral elements or discontinuous Galerkin will be ideal, but I want to get petsc experience first with simpler problem and then move to discontinuous Galerkin (this will be defiantly the next step). (Unfortunately, I have never done any unstructured meshes like spectral elements or discontinuous Galerkin myself before, but did some finite difference and spectral methods) >>>>>>>> >>>>>>>> On 07/30/2017 12:46 PM, Matthew Knepley wrote: >>>>>>>>> On Sun, Jul 30, 2017 at 12:44 PM, Oleksandr Koshkarov wrote: >>>>>>>>> Thanks for the references, and warning. >>>>>>>>> >>>>>>>>> I am trying to do exactly this >>>>>>>>> http://www.sciencedirect.com/science/article/pii/S0021999115004738 >>>>>>>>> >>>>>>>>> (I probably should have added the reference in the first place, sorry) >>>>>>>>> >>>>>>>>> the evolution formula is (15) in the article. >>>>>>>>> >>>>>>>>> So, I will do convolution only in 3D (while full system is 6D) because velocity space is not discretized with Fourier >>>>>>>>> >>>>>>>>> So As I understand, it will not be N^2 vs N logN. Moreover, I know that algorithm with FFT has significantly larger "constant". >>>>>>>>> >>>>>>>>> Please correct me if I am wrong here :) >>>>>>>>> >>>>>>>>> I think you are wrong here. First, I do not understand why you think the asymptotics have changed. Second, the constant for >>>>>>>>> FFT is about 6, which would be really hard to beat with a quadrature. >>>>>>>>> >>>>>>>>> Last, this discretization looks fully coupled to me. I cannot see how you would parallelize this right off the bat. This is a problem >>>>>>>>> with spectral discretizations, and the main motivator for spectral elements. >>>>>>>>> >>>>>>>>> Thanks, >>>>>>>>> >>>>>>>>> Matt >>>>>>>>> I know for sure that FFT is a must at the end, but I thought I can start with matrix product to get more familiar with PETSc as it will be simpler to implement (At least I think so). >>>>>>>>> >>>>>>>>> I hope it does make sense. >>>>>>>>> >>>>>>>>> Another question about convolution via matrix product. Is there better way to do it other then to construct NxN Toeplitz-like matrix each time step on the "fly" from state vector and then multiply it to state vector? >>>>>>>>> >>>>>>>>> p.s. Probably I should do FFT from the start, but I am a little bit intimidated by the problem taking into account that I do not have PETSc experience. >>>>>>>>> Best regards, >>>>>>>>> Oleksandr Koshkarov. >>>>>>>>> >>>>>>>>> On 07/30/2017 09:01 AM, Matthew Knepley wrote: >>>>>>>>>> On Sat, Jul 29, 2017 at 7:01 PM, Oleksandr Koshkarov wrote: >>>>>>>>>> Thank you for the response, >>>>>>>>>> >>>>>>>>>> Now that you said about additional communication for fft, I want to ask another question: >>>>>>>>>> >>>>>>>>>> What if I disregard FFT and will compute convolution directly, I will rewrite it as vector-matrix-vector product >>>>>>>>>> >>>>>>>>>> I would caution you here. The algorithm is the most important thing to get right up front. In this case, the effect of >>>>>>>>>> dimension will be dominant, and anything that does not scale well with dimension will be thrown away, perhaps >>>>>>>>>> quite quickly, as you want to solve bigger problems. >>>>>>>>>> >>>>>>>>>> Small calculation: Take a 6-dim box which is 'n' on a side, so that N = n^6. FFT is N log N, whereas direct evaluation of >>>>>>>>>> a convolution is N^2. So if we could do n = 100 points on a side with FFT, you can do, assuming the constants are about >>>>>>>>>> equal, >>>>>>>>>> >>>>>>>>>> 100^6 (log 100^6) = x^12 >>>>>>>>>> 1e12 (6 2) = x^12 >>>>>>>>>> x ~ 10 >>>>>>>>>> >>>>>>>>>> Past versions of PETSc had a higher dimensional DA construct (adda in prior versions), but no one used it so we removed it. >>>>>>>>>> >>>>>>>>>> I assume you are proposing something like >>>>>>>>>> >>>>>>>>>> https://arxiv.org/abs/1306.4625 >>>>>>>>>> >>>>>>>>>> or maybe >>>>>>>>>> >>>>>>>>>> https://arxiv.org/abs/1610.00397 >>>>>>>>>> >>>>>>>>>> The later is interesting since I think you could use a DMDA for the velocity and something like DMPlex for the space. >>>>>>>>>> >>>>>>>>>> Thanks, >>>>>>>>>> >>>>>>>>>> Matt >>>>>>>>>> >>>>>>>>>> x^T A x (where T - is transpose, x - is my state vector, and A is a matrix which represents convolution and probably it will be not very sparse). >>>>>>>>>> >>>>>>>>>> Yes - I will do more work (alghorithm will be slower), but will I win if we take the parallelization into account - less communication + probably more scalable algorithm? >>>>>>>>>> >>>>>>>>>> Best regards, >>>>>>>>>> >>>>>>>>>> Alex. >>>>>>>>>> >>>>>>>>>> >>>>>>>>>> >>>>>>>>>> On 07/29/2017 05:23 PM, Barry Smith wrote: >>>>>>>>>> DMDA provides a simple way to do domain decomposition of structured grid meshes in the x, y, and z direction, that is it makes it easy to efficiently chop up vectors in all 3 dimensions, allowing very large problems easily. Unfortunately it only goes up to 3 dimensions and attempts to produce versions for higher dimensions have failed. >>>>>>>>>> >>>>>>>>>> If you would like to do domain decomposition across all six of your dimensions (which I think you really need to do to solve large problems) we don't have a tool that helps with doing the domain decomposition. To make matters more complicated, likely the 3d mpi-fftw that need to be applied require rejiggering the data across the nodes to get it into a form where the ffts can be applied efficiently. >>>>>>>>>> >>>>>>>>>> I don't think there is necessarily anything theoretically difficult about managing the six dimensional domain decomposition I just don't know of any open source software out there that helps to do this. Maybe some PETSc users are aware of such software and can chime in. >>>>>>>>>> >>>>>>>>>> Aside from these two issues :-) PETSc would be useful for you since you could use our time integrators and nonlinear solvers. Pulling out subvectors to process on can be done with with either VecScatter or VecStrideScatter, VecStrideGather etc depending on the layout of the unknowns, i.e. how the domain decomposition is done. >>>>>>>>>> >>>>>>>>>> I wish I had better answers for managing the 6d domain decomposition >>>>>>>>>> >>>>>>>>>> Barry >>>>>>>>>> >>>>>>>>>> >>>>>>>>>> >>>>>>>>>> >>>>>>>>>> On Jul 29, 2017, at 5:06 PM, Oleksandr Koshkarov wrote: >>>>>>>>>> >>>>>>>>>> Dear All, >>>>>>>>>> >>>>>>>>>> I am a new PETSc user and I am still in the middle of the manual (I have finally settled to choose PETSc as my main numerical library) so I am sorry beforehand if my questions would be naive. >>>>>>>>>> >>>>>>>>>> I am trying to solve 6+1 dimensional Vlasov equation with spectral methods. More precisely, I will try to solve half-discretized equations of the form (approximate form) with pseudospectral Fourier method: >>>>>>>>>> >>>>>>>>>> (Equations are in latex format, the nice website to see them is https://www.codecogs.com/latex/eqneditor.php) >>>>>>>>>> >>>>>>>>>> \frac{dC_{m,m,p}}{dt} =\\ >>>>>>>>>> \partial_x \left ( a_n C_{n+1,m,p} +b_n C_{n,m,p} +c_n C_{n-1,m,p} \right ) \\ >>>>>>>>>> + \partial_y \left ( a_m C_{n,m+1,p} +b_m C_{n,m,p} +c_m C_{n,m-1,p} \right ) \\ >>>>>>>>>> + \partial_z \left ( a_p C_{n,m,p+1} +b_p C_{n,m,p} +c_p C_{n,m,p-1} \right ) \\ >>>>>>>>>> + d_n E_x C_{n-1,m,p} + d_m E_x C_{n,m-1,p} + d_p E_x C_{n,m,p-1} \\ >>>>>>>>>> + B_x (e_{m,p} C_{n,m-1,p-1} + f_{m,p}C_{n,m-1,p+1} + \dots) + B_y (\dots) + B_z (\dots) >>>>>>>>>> >>>>>>>>>> >>>>>>>>>> where a,b,c,d,e,f are some constants which can depend on n,m,p, >>>>>>>>>> >>>>>>>>>> n,m,p = 0...N, >>>>>>>>>> >>>>>>>>>> C_{n,m,p} = C_{n,m,p}(x,y,z), >>>>>>>>>> >>>>>>>>>> E_x = E_x(x,y,z), (same for E_y,B_x,...) >>>>>>>>>> >>>>>>>>>> and fields are described with equation of the sort (linear pdes with source terms dependent on C): >>>>>>>>>> >>>>>>>>>> \frac{dE_x}{dt} = \partial_y B_z - \partial_z B_x + (AC_{1,0,0} + BC_{0,0,0}) \\ >>>>>>>>>> \frac{dB_x}{dt} = -\partial_y E_z + \partial_z E_x >>>>>>>>>> >>>>>>>>>> with A,B being some constants. >>>>>>>>>> >>>>>>>>>> I will need fully implicit Crank?Nicolson method, so my plan is to use SNES or TS where >>>>>>>>>> >>>>>>>>>> I will use one MPI PETSc vector which describes the state of the system (all, C, E, B), then I can evolve linear part with just matrix multiplication. >>>>>>>>>> >>>>>>>>>> The first question is, should I use something like DMDA? if so, it is only 3dimensional but I need 6 dimensional vectots? Will it be faster then matrix multiplication? >>>>>>>>>> >>>>>>>>>> Then to do nonlinear part I will need 3d mpi-fftw to compute convolutions. The problem is, how do I extract subvectors from full big vector state? (what is the best approach?) >>>>>>>>>> >>>>>>>>>> If you have some other suggestions, please feel free to share >>>>>>>>>> >>>>>>>>>> Thanks and best regards, >>>>>>>>>> >>>>>>>>>> Oleksandr Koshkarov. >>>>>>>>>> >>>>>>>>>> >>>>>>>>>> >>>>>>>>>> >>>>>>>>>> >>>>>>>>>> -- >>>>>>>>>> What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. >>>>>>>>>> -- Norbert Wiener >>>>>>>>>> >>>>>>>>>> http://www.caam.rice.edu/~mk51/ >>>>>>>>> -- >>>>>>>>> What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. >>>>>>>>> -- Norbert Wiener >>>>>>>>> >>>>>>>>> http://www.caam.rice.edu/~mk51/ From gotofd at gmail.com Wed Aug 2 10:54:01 2017 From: gotofd at gmail.com (Ji Zhang) Date: Wed, 2 Aug 2017 23:54:01 +0800 Subject: [petsc-users] Accelerate convergence of some specified unknowns of the matrix equation. Message-ID: Dear all, I'm a PETSc user, solving some matrix equations using GMRES method. The matrix is dense and huge, i.e. 10,000~100,000 unknowns. But I'm only interested in the last six unknowns. Is it possible to accelerate the convergence rate of them, even others are less accuracy. Thanks. Best, Regards, Zhang Ji, PhD student Beijing Computational Science Research Center Zhongguancun Software Park II, No. 10 Dongbeiwang West Road, Haidian District, Beijing 100193, China -------------- next part -------------- An HTML attachment was scrubbed... URL: From jed at jedbrown.org Wed Aug 2 22:09:47 2017 From: jed at jedbrown.org (Jed Brown) Date: Wed, 02 Aug 2017 21:09:47 -0600 Subject: [petsc-users] Accelerate convergence of some specified unknowns of the matrix equation. In-Reply-To: References: Message-ID: <87lgn1ny84.fsf@jedbrown.org> This usually isn't possible for iterative solvers and saves very little for direct solvers (you still have to pay the factorization cost, but can save a little on solve cost which is already vastly cheaper). While it's easy to make the residual zero for some subset of unknowns, that says nothing about the solution, which can still be completely wrong until the solution converges everywhere. Ji Zhang writes: > Dear all, > > I'm a PETSc user, solving some matrix equations using GMRES method. The > matrix is dense and huge, i.e. 10,000~100,000 unknowns. But I'm only > interested in the last six unknowns. Is it possible to accelerate the > convergence rate of them, even others are less accuracy. > > Thanks. > > Best, > Regards, > Zhang Ji, PhD student > Beijing Computational Science Research Center > Zhongguancun Software Park II, No. 10 Dongbeiwang West Road, Haidian > District, Beijing 100193, China -------------- next part -------------- A non-text attachment was scrubbed... Name: signature.asc Type: application/pgp-signature Size: 832 bytes Desc: not available URL: From a.croucher at auckland.ac.nz Thu Aug 3 22:07:29 2017 From: a.croucher at auckland.ac.nz (Adrian Croucher) Date: Fri, 4 Aug 2017 15:07:29 +1200 Subject: [petsc-users] DMPlex ghost cells Message-ID: I am adding cells onto a DMPlex (for dual porosity). I notice that normally the ghost cells in a DMPlex are at the end of the cell list. Does it matter if the cells I add come after those ghost cells, or should the ghosts always come last? It seems to me it probably shoudn't matter if the partition ghosts (created by DMPlexDistribute()) are not at the end. In my cell loops I just check the value of the ghost DMLabel and skip them if necessary. But perhaps the boundary ghosts (created by DMPlexConstructGhostCells()) need to come last? Otherwise the output from DMPlexGetHybridBounds() (to get the bounds on 'interior' cells, i.e. non-boundary-ghosts) probably wouldn't make much sense? - Adrian -- Dr Adrian Croucher Senior Research Fellow Department of Engineering Science University of Auckland, New Zealand email: a.croucher at auckland.ac.nz tel: +64 (0)9 923 4611 From knepley at gmail.com Thu Aug 3 22:11:31 2017 From: knepley at gmail.com (Matthew Knepley) Date: Thu, 3 Aug 2017 22:11:31 -0500 Subject: [petsc-users] DMPlex ghost cells In-Reply-To: References: Message-ID: On Thu, Aug 3, 2017 at 10:07 PM, Adrian Croucher wrote: > I am adding cells onto a DMPlex (for dual porosity). I notice that > normally the ghost cells in a DMPlex are at the end of the cell list. > > Does it matter if the cells I add come after those ghost cells, or should > the ghosts always come last? > > It seems to me it probably shoudn't matter if the partition ghosts > (created by DMPlexDistribute()) are not at the end. In my cell loops I just > check the value of the ghost DMLabel and skip them if necessary. > > But perhaps the boundary ghosts (created by DMPlexConstructGhostCells()) > need to come last? Otherwise the output from DMPlexGetHybridBounds() (to > get the bounds on 'interior' cells, i.e. non-boundary-ghosts) probably > wouldn't make much sense? Yes, the only reason to have them last is to have GetHybridBounds() work for that case. Thanks, Matt > > - Adrian > > -- > Dr Adrian Croucher > Senior Research Fellow > Department of Engineering Science > University of Auckland, New Zealand > email: a.croucher at auckland.ac.nz > tel: +64 (0)9 923 4611 > > -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener http://www.caam.rice.edu/~mk51/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From a.croucher at auckland.ac.nz Thu Aug 3 22:52:04 2017 From: a.croucher at auckland.ac.nz (Adrian Croucher) Date: Fri, 4 Aug 2017 15:52:04 +1200 Subject: [petsc-users] DMPlex ghost cells In-Reply-To: References: Message-ID: <94d119c2-ac12-42bb-7b6a-0eacae5005c5@auckland.ac.nz> Would it also work if I just didn't use DMPlexGetHybridBounds() to differentiate between partition ghost cells and boundary ghost cells, but instead checked the value of the "ghost" DMLabel? It appears that DMPlexConstructGhostCells() labels boundary ghosts with the ghost label value 1, and partition ghosts with value 2 (in DMPlexShiftLabels_Internal()). If that is reliable, then it might save me having to make sure the boundary ghosts always come last. - Adrian On 04/08/17 15:11, Matthew Knepley wrote: > On Thu, Aug 3, 2017 at 10:07 PM, Adrian Croucher > > wrote: > > I am adding cells onto a DMPlex (for dual porosity). I notice that > normally the ghost cells in a DMPlex are at the end of the cell list. > > Does it matter if the cells I add come after those ghost cells, or > should the ghosts always come last? > > It seems to me it probably shoudn't matter if the partition ghosts > (created by DMPlexDistribute()) are not at the end. In my cell > loops I just check the value of the ghost DMLabel and skip them if > necessary. > > But perhaps the boundary ghosts (created by > DMPlexConstructGhostCells()) need to come last? Otherwise the > output from DMPlexGetHybridBounds() (to get the bounds on > 'interior' cells, i.e. non-boundary-ghosts) probably wouldn't make > much sense? > > > Yes, the only reason to have them last is to have GetHybridBounds() > work for that case. > > Thanks, > > Matt > > > - Adrian > > -- > Dr Adrian Croucher > Senior Research Fellow > Department of Engineering Science > University of Auckland, New Zealand > email: a.croucher at auckland.ac.nz > tel: +64 (0)9 923 4611 > > > > > -- > What most experimenters take for granted before they begin their > experiments is infinitely more interesting than any results to which > their experiments lead. > -- Norbert Wiener > > http://www.caam.rice.edu/~mk51/ -- Dr Adrian Croucher Senior Research Fellow Department of Engineering Science University of Auckland, New Zealand email: a.croucher at auckland.ac.nz tel: +64 (0)9 923 4611 -------------- next part -------------- An HTML attachment was scrubbed... URL: From lawrence.mitchell at imperial.ac.uk Fri Aug 4 09:37:00 2017 From: lawrence.mitchell at imperial.ac.uk (Lawrence Mitchell) Date: Fri, 4 Aug 2017 15:37:00 +0100 Subject: [petsc-users] DMPlex distribution with custom adjacency In-Reply-To: <68964A27-CA4F-4527-8F18-6F231997451F@imperial.ac.uk> References: <15e465f7-dea1-39c5-7c43-ba447a7a8c09@imperial.ac.uk> <54529998-4688-4774-845B-1FDF67A8C20B@imperial.ac.uk> <0BEB36D4-C35B-48E4-8F66-8EE8D38E08B6@imperial.ac.uk> <6C66D04E-72AD-445B-9DE6-BB0961B9F622@imperial.ac.uk> <0b55eaf7-bf06-3876-a6bb-ce8e54422fa1@imperial.ac.uk> <7E354BC8-1419-4803-B8F6-CA78F868972A@imperial.ac.uk> <68964A27-CA4F-4527-8F18-6F231997451F@imperial.ac.uk> Message-ID: <55066281-4ED0-4B47-9711-045B55D56823@imperial.ac.uk> > On 6 Jun 2017, at 09:01, Lawrence Mitchell wrote: > >> If you do really want to prune them, then I guess overriding the DMPlexGetAdjacency() as you propose is probably the best way. I would >> be willing to put it in. Please send me a reminder email since this week is pretty heinous for me. Coming back to this after a while. It would still be good if I could provide a callback for user-defined adjacency. Does https://bitbucket.org/petsc/petsc/pull-requests/690/plex-support-user-defined-adjacencies-via/diff look suitable? Cheers, Lawrence From knepley at gmail.com Fri Aug 4 09:37:51 2017 From: knepley at gmail.com (Matthew Knepley) Date: Fri, 4 Aug 2017 09:37:51 -0500 Subject: [petsc-users] DMPlex ghost cells In-Reply-To: <94d119c2-ac12-42bb-7b6a-0eacae5005c5@auckland.ac.nz> References: <94d119c2-ac12-42bb-7b6a-0eacae5005c5@auckland.ac.nz> Message-ID: On Thu, Aug 3, 2017 at 10:52 PM, Adrian Croucher wrote: > Would it also work if I just didn't use DMPlexGetHybridBounds() to > differentiate between partition ghost cells and boundary ghost cells, but > instead checked the value of the "ghost" DMLabel? > Yes. Matt > It appears that DMPlexConstructGhostCells() labels boundary ghosts with > the ghost label value 1, and partition ghosts with value 2 (in > DMPlexShiftLabels_Internal()). > > If that is reliable, then it might save me having to make sure the > boundary ghosts always come last. > > - Adrian > > On 04/08/17 15:11, Matthew Knepley wrote: > > On Thu, Aug 3, 2017 at 10:07 PM, Adrian Croucher < > a.croucher at auckland.ac.nz> wrote: > >> I am adding cells onto a DMPlex (for dual porosity). I notice that >> normally the ghost cells in a DMPlex are at the end of the cell list. >> >> Does it matter if the cells I add come after those ghost cells, or should >> the ghosts always come last? >> >> It seems to me it probably shoudn't matter if the partition ghosts >> (created by DMPlexDistribute()) are not at the end. In my cell loops I just >> check the value of the ghost DMLabel and skip them if necessary. >> >> But perhaps the boundary ghosts (created by DMPlexConstructGhostCells()) >> need to come last? Otherwise the output from DMPlexGetHybridBounds() (to >> get the bounds on 'interior' cells, i.e. non-boundary-ghosts) probably >> wouldn't make much sense? > > > Yes, the only reason to have them last is to have GetHybridBounds() work > for that case. > > Thanks, > > Matt > > >> >> - Adrian >> >> -- >> Dr Adrian Croucher >> Senior Research Fellow >> Department of Engineering Science >> University of Auckland, New Zealand >> email: a.croucher at auckland.ac.nz >> tel: +64 (0)9 923 4611 >> >> > > > -- > What most experimenters take for granted before they begin their > experiments is infinitely more interesting than any results to which their > experiments lead. > -- Norbert Wiener > > http://www.caam.rice.edu/~mk51/ > > > -- > Dr Adrian Croucher > Senior Research Fellow > Department of Engineering Science > University of Auckland, New Zealand > email: a.croucher at auckland.ac.nz > tel: +64 (0)9 923 4611 <+64%209-923%204611> > > -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener http://www.caam.rice.edu/~mk51/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From knepley at gmail.com Fri Aug 4 10:53:21 2017 From: knepley at gmail.com (Matthew Knepley) Date: Fri, 4 Aug 2017 10:53:21 -0500 Subject: [petsc-users] DMPlex distribution with custom adjacency In-Reply-To: <55066281-4ED0-4B47-9711-045B55D56823@imperial.ac.uk> References: <15e465f7-dea1-39c5-7c43-ba447a7a8c09@imperial.ac.uk> <54529998-4688-4774-845B-1FDF67A8C20B@imperial.ac.uk> <0BEB36D4-C35B-48E4-8F66-8EE8D38E08B6@imperial.ac.uk> <6C66D04E-72AD-445B-9DE6-BB0961B9F622@imperial.ac.uk> <0b55eaf7-bf06-3876-a6bb-ce8e54422fa1@imperial.ac.uk> <7E354BC8-1419-4803-B8F6-CA78F868972A@imperial.ac.uk> <68964A27-CA4F-4527-8F18-6F231997451F@imperial.ac.uk> <55066281-4ED0-4B47-9711-045B55D56823@imperial.ac.uk> Message-ID: On Fri, Aug 4, 2017 at 9:37 AM, Lawrence Mitchell < lawrence.mitchell at imperial.ac.uk> wrote: > > > On 6 Jun 2017, at 09:01, Lawrence Mitchell ac.uk> wrote: > > > >> If you do really want to prune them, then I guess overriding the > DMPlexGetAdjacency() as you propose is probably the best way. I would > >> be willing to put it in. Please send me a reminder email since this > week is pretty heinous for me. > > Coming back to this after a while. It would still be good if I could > provide a callback for user-defined adjacency. Does > https://bitbucket.org/petsc/petsc/pull-requests/690/plex- > support-user-defined-adjacencies-via/diff look suitable? > Yes. Karl, could you merge? Thanks, Matt > Cheers, > > Lawrence -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener http://www.caam.rice.edu/~mk51/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From epscodes at gmail.com Fri Aug 4 14:52:55 2017 From: epscodes at gmail.com (Xiangdong) Date: Fri, 4 Aug 2017 15:52:55 -0400 Subject: [petsc-users] MatMPIAIJSetPreallocation question Message-ID: Hello everyone, I have a quick questions on the MatMPIAIJSetPreallocation. If we do not pass the exact number of nonzeros for o_nnz and d_nnz, (for example, MAT_INFO_NZ_ALLOCATED is 50% more than MAT_INFO_NZ_USED), will the performance of MatMult be affected? What effect will these allocated but unused memory cause? Thank you. Best, Xiangdong -------------- next part -------------- An HTML attachment was scrubbed... URL: From rupp at iue.tuwien.ac.at Fri Aug 4 15:02:05 2017 From: rupp at iue.tuwien.ac.at (Karl Rupp) Date: Fri, 4 Aug 2017 15:02:05 -0500 Subject: [petsc-users] DMPlex distribution with custom adjacency In-Reply-To: References: <54529998-4688-4774-845B-1FDF67A8C20B@imperial.ac.uk> <0BEB36D4-C35B-48E4-8F66-8EE8D38E08B6@imperial.ac.uk> <6C66D04E-72AD-445B-9DE6-BB0961B9F622@imperial.ac.uk> <0b55eaf7-bf06-3876-a6bb-ce8e54422fa1@imperial.ac.uk> <7E354BC8-1419-4803-B8F6-CA78F868972A@imperial.ac.uk> <68964A27-CA4F-4527-8F18-6F231997451F@imperial.ac.uk> <55066281-4ED0-4B47-9711-045B55D56823@imperial.ac.uk> Message-ID: > Coming back to this after a while. It would still be good if I > could provide a callback for user-defined adjacency. Does > https://bitbucket.org/petsc/petsc/pull-requests/690/plex-support-user-defined-adjacencies-via/diff > > look suitable? > > > Yes. Karl, could you merge? Now in next. Best regards, Karli From bsmith at mcs.anl.gov Fri Aug 4 15:52:12 2017 From: bsmith at mcs.anl.gov (Barry Smith) Date: Fri, 4 Aug 2017 15:52:12 -0500 Subject: [petsc-users] MatMPIAIJSetPreallocation question In-Reply-To: References: Message-ID: <11D43206-6C75-4C28-8952-D29B21442C5C@mcs.anl.gov> > On Aug 4, 2017, at 2:52 PM, Xiangdong wrote: > > Hello everyone, > > I have a quick questions on the MatMPIAIJSetPreallocation. If we do not pass the exact number of nonzeros for o_nnz and d_nnz, (for example, MAT_INFO_NZ_ALLOCATED is 50% more than MAT_INFO_NZ_USED), will the performance of MatMult be affected? What effect will these allocated but unused memory cause? It is not a big deal to have extra memory, it won't slow things down. If you under estimate it can slow things down a lot. > > Thank you. > > Best, > Xiangdong From epscodes at gmail.com Mon Aug 7 07:40:39 2017 From: epscodes at gmail.com (Xiangdong) Date: Mon, 7 Aug 2017 08:40:39 -0400 Subject: [petsc-users] MatMPIAIJSetPreallocation question In-Reply-To: <11D43206-6C75-4C28-8952-D29B21442C5C@mcs.anl.gov> References: <11D43206-6C75-4C28-8952-D29B21442C5C@mcs.anl.gov> Message-ID: Hi Barry, Thanks for your response. So these extra allocated memory is just a waste of memory, but no harm for other mat related computation. Is it correct? Thank you. Xiangdong On Fri, Aug 4, 2017 at 4:52 PM, Barry Smith wrote: > > > On Aug 4, 2017, at 2:52 PM, Xiangdong wrote: > > > > Hello everyone, > > > > I have a quick questions on the MatMPIAIJSetPreallocation. If we do not > pass the exact number of nonzeros for o_nnz and d_nnz, (for example, > MAT_INFO_NZ_ALLOCATED is 50% more than MAT_INFO_NZ_USED), will the > performance of MatMult be affected? What effect will these allocated but > unused memory cause? > > It is not a big deal to have extra memory, it won't slow things down. > If you under estimate it can slow things down a lot. > > > > > Thank you. > > > > Best, > > Xiangdong > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Mon Aug 7 07:49:58 2017 From: bsmith at mcs.anl.gov (Barry Smith) Date: Mon, 7 Aug 2017 07:49:58 -0500 Subject: [petsc-users] MatMPIAIJSetPreallocation question In-Reply-To: References: <11D43206-6C75-4C28-8952-D29B21442C5C@mcs.anl.gov> Message-ID: <7FF92ED8-8824-4653-930D-206DF36745C6@mcs.anl.gov> > On Aug 7, 2017, at 7:40 AM, Xiangdong wrote: > > Hi Barry, > > Thanks for your response. So these extra allocated memory is just a waste of memory, but no harm for other mat related computation. Is it correct? Yes, and given how virtual memory works with pages it isn't even much of a waste of memory. > > Thank you. > > Xiangdong > > On Fri, Aug 4, 2017 at 4:52 PM, Barry Smith wrote: > > > On Aug 4, 2017, at 2:52 PM, Xiangdong wrote: > > > > Hello everyone, > > > > I have a quick questions on the MatMPIAIJSetPreallocation. If we do not pass the exact number of nonzeros for o_nnz and d_nnz, (for example, MAT_INFO_NZ_ALLOCATED is 50% more than MAT_INFO_NZ_USED), will the performance of MatMult be affected? What effect will these allocated but unused memory cause? > > It is not a big deal to have extra memory, it won't slow things down. If you under estimate it can slow things down a lot. > > > > > Thank you. > > > > Best, > > Xiangdong > > From j.pogacnik at auckland.ac.nz Mon Aug 7 13:44:56 2017 From: j.pogacnik at auckland.ac.nz (Justin Pogacnik) Date: Mon, 7 Aug 2017 18:44:56 +0000 Subject: [petsc-users] [FORGED] Re: NULL section fortran In-Reply-To: <1500323901867.83412@auckland.ac.nz> References: <1499889127627.57606@auckland.ac.nz>, , <1500323901867.83412@auckland.ac.nz> Message-ID: <1502131496827.30545@auckland.ac.nz> Any word on this? Thanks again! -Justin ________________________________________ From: Justin Pogacnik Sent: Tuesday, July 18, 2017 8:38 AM To: Barry Smith Cc: petsc-users at mcs.anl.gov Subject: Re: [FORGED] Re: [petsc-users] NULL section fortran Thanks for the response Barry. Matt, is this something that will be pushed out soon(ish)? Thanks guys! Justin ________________________________________ From: Barry Smith Sent: Thursday, July 13, 2017 7:59 AM To: Justin Pogacnik Cc: petsc-users at mcs.anl.gov Subject: [FORGED] Re: [petsc-users] NULL section fortran Matt needs to add something like PetscSection, parameter :: PETSC_NULL_SECTION = tPetscSection(-1) PetscSectionSym, parameter :: PETSC_NULL_SECTIONSYM = tPetscSectionSym(-1) to src/vec/f90-mod/petscis.h in the master branch. Barry > On Jul 12, 2017, at 2:52 PM, Justin Pogacnik wrote: > > Hello, > > I'm assembling a global finite element stiffness matrix and using the DMPlexMatSetClosure command in fortran. Long ago, in the past, I've used to set the section input parameters to PETSC_NULL_OBJECT. That now returns an error -- no implicit type -- during compilation. Looking at the defined null objects for fortran I don't see a section option. What should I use to invoke the default sections? > > Hope this makes sense. Thanks! > > Justin From knepley at gmail.com Mon Aug 7 13:49:46 2017 From: knepley at gmail.com (Matthew Knepley) Date: Mon, 7 Aug 2017 13:49:46 -0500 Subject: [petsc-users] [FORGED] Re: NULL section fortran In-Reply-To: <1502131496827.30545@auckland.ac.nz> References: <1499889127627.57606@auckland.ac.nz> <1500323901867.83412@auckland.ac.nz> <1502131496827.30545@auckland.ac.nz> Message-ID: On Mon, Aug 7, 2017 at 1:44 PM, Justin Pogacnik wrote: > Any word on this? Thanks again! > Should be in master. Thanks, Matt > -Justin > ________________________________________ > From: Justin Pogacnik > Sent: Tuesday, July 18, 2017 8:38 AM > To: Barry Smith > Cc: petsc-users at mcs.anl.gov > Subject: Re: [FORGED] Re: [petsc-users] NULL section fortran > > Thanks for the response Barry. Matt, is this something that will be pushed > out soon(ish)? > > Thanks guys! > > Justin > ________________________________________ > From: Barry Smith > Sent: Thursday, July 13, 2017 7:59 AM > To: Justin Pogacnik > Cc: petsc-users at mcs.anl.gov > Subject: [FORGED] Re: [petsc-users] NULL section fortran > > Matt needs to add something like > > PetscSection, parameter :: PETSC_NULL_SECTION = tPetscSection(-1) > PetscSectionSym, parameter :: PETSC_NULL_SECTIONSYM = > tPetscSectionSym(-1) > > to src/vec/f90-mod/petscis.h in the master branch. > > Barry > > > > On Jul 12, 2017, at 2:52 PM, Justin Pogacnik > wrote: > > > > Hello, > > > > I'm assembling a global finite element stiffness matrix and using the > DMPlexMatSetClosure command in fortran. Long ago, in the past, I've used to > set the section input parameters to PETSC_NULL_OBJECT. That now returns an > error -- no implicit type -- during compilation. Looking at the defined > null objects for fortran I don't see a section option. What should I use to > invoke the default sections? > > > > Hope this makes sense. Thanks! > > > > Justin > -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener http://www.caam.rice.edu/~mk51/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From j.pogacnik at auckland.ac.nz Mon Aug 7 13:57:40 2017 From: j.pogacnik at auckland.ac.nz (Justin Pogacnik) Date: Mon, 7 Aug 2017 18:57:40 +0000 Subject: [petsc-users] [FORGED] Re: NULL section fortran In-Reply-To: References: <1499889127627.57606@auckland.ac.nz> <1500323901867.83412@auckland.ac.nz> <1502131496827.30545@auckland.ac.nz>, Message-ID: <1502132260930.17476@auckland.ac.nz> ?Thanks Matt! ________________________________ From: Matthew Knepley Sent: Tuesday, August 8, 2017 6:49 AM To: Justin Pogacnik Cc: petsc-users at mcs.anl.gov Subject: Re: [petsc-users] [FORGED] Re: NULL section fortran On Mon, Aug 7, 2017 at 1:44 PM, Justin Pogacnik > wrote: Any word on this? Thanks again! Should be in master. Thanks, Matt -Justin ________________________________________ From: Justin Pogacnik Sent: Tuesday, July 18, 2017 8:38 AM To: Barry Smith Cc: petsc-users at mcs.anl.gov Subject: Re: [FORGED] Re: [petsc-users] NULL section fortran Thanks for the response Barry. Matt, is this something that will be pushed out soon(ish)? Thanks guys! Justin ________________________________________ From: Barry Smith > Sent: Thursday, July 13, 2017 7:59 AM To: Justin Pogacnik Cc: petsc-users at mcs.anl.gov Subject: [FORGED] Re: [petsc-users] NULL section fortran Matt needs to add something like PetscSection, parameter :: PETSC_NULL_SECTION = tPetscSection(-1) PetscSectionSym, parameter :: PETSC_NULL_SECTIONSYM = tPetscSectionSym(-1) to src/vec/f90-mod/petscis.h in the master branch. Barry > On Jul 12, 2017, at 2:52 PM, Justin Pogacnik > wrote: > > Hello, > > I'm assembling a global finite element stiffness matrix and using the DMPlexMatSetClosure command in fortran. Long ago, in the past, I've used to set the section input parameters to PETSC_NULL_OBJECT. That now returns an error -- no implicit type -- during compilation. Looking at the defined null objects for fortran I don't see a section option. What should I use to invoke the default sections? > > Hope this makes sense. Thanks! > > Justin -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener http://www.caam.rice.edu/~mk51/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From jed at jedbrown.org Wed Aug 9 11:01:30 2017 From: jed at jedbrown.org (Jed Brown) Date: Wed, 09 Aug 2017 10:01:30 -0600 Subject: [petsc-users] Call for Participation - SIAM PP18, March 7-10, 2018, Tokyo, Japan Message-ID: <87zib8u3vp.fsf@jedbrown.org> ***************************************************************************** CALL FOR PARTICIPATION SIAM Conference on Parallel Processing for Scientific Computing (PP18) March 7-10, 2018, Waseda University, Tokyo, Japan https://www.siam.org/meetings/pp18/ http://siampp18.jsiam.org/ Twitter hashtag: #SIAMPP18 ***************************************************************************** Important Dates: Aug.21, 2017: Minisymposium proposal Submissions Sep.18, 2017: Contributed Lecture, Poster and Minisymposium Presentation Abstracts Sep.08, 2017: SIAM Student Travel Award & Early Career Travel Award Applications Hosted by: SIAM Activity Group on Supercomputing (SIAG/SC) The Japan Society for Industrial and Applied Mathematics (JSIAM) Waseda University SIAM Conference on Parallel Processing for Scientific Computing, hosted by SIAM Activity Group on Supercomputing, is one of the most important meetings on algorithms and applications for parallel processing. The meeting is held every second year, and more than 400 experts from all over the world attend it in recent years. The 16th meeting in 2018 (SIAM PP18) will be held at the Nishi-Waseda Campus of Waseda University, Tokyo, Japan. ----------------------------------------- #Invited Speakers: Takuya Akiba, Preferred Networks, Japan Haohuan Fu, National Supercomputing Center, Wuxi, China Tsuyoshi Ichimura, Earthquake Research Institute, The University of Tokyo, Japan Lois Curfman McInnes, Argonne National Laboratory, USA Shin'ichi Oishi, Waseda University, Japan John Shalf, Lawrence Berkeley National Laboratory, USA Wim Vanroose, University of Antwerp, Belgium Chao Yang, Chinese Academy of Science, China #Co-Chairs of the Conference Organizing Committee: Satoshi Matsuoka, Tokyo Institute of Technology, Japan Kengo Nakajima, Information Technology Center, The University of Tokyo , Japan Olaf Schenk, Universita della Svizzera italiana, Switzerland -------------- next part -------------- A non-text attachment was scrubbed... Name: signature.asc Type: application/pgp-signature Size: 832 bytes Desc: not available URL: From gaetank at gmail.com Fri Aug 11 12:14:50 2017 From: gaetank at gmail.com (Gaetan Kenway) Date: Fri, 11 Aug 2017 10:14:50 -0700 Subject: [petsc-users] Petsc ILU PC Change between 3.6.4 and 3.7.x? Message-ID: Hi All I'm in the process of updating a code that uses PETSc for solving linear systems for an unstructured CFD code. As of recently, it was using an ancient version (3.3). However, when I updated it up to 3.7.6 I ended up running into issues with one of the KSP solves. The remainder of the code is identical, I've tracked the issue down to occurring between version 3.6.4 and version 3.7.0 . The same issue is present on the most recent version 3.7.6. Specifically the issue is that on the second iteration, on the 3.7 version the KSP kicks out with KSP converged reason of -11 or KSP_DIVERGED_PCSETUP_FAILED . After that the two runs differ. The KSPView for each of the two are given below which are identical, up to small formatting changes. There is still more I can track down, but I thought I would ask if someone knows what might have changed between these two versions which could save me a lot of time. Thanks, Gaetan 3.6 KSP View: KSP Object: 8 MPI processes type: gmres GMRES: restart=3, using Classical (unmodified) Gram-Schmidt Orthogonalization with no iterative refinement GMRES: happy breakdown tolerance 1e-30 maximum iterations=3 using preconditioner applied to right hand side for initial guess tolerances: relative=1e-08, absolute=1e-20, divergence=1e+15 left preconditioning using nonzero initial guess using PRECONDITIONED norm type for convergence test PC Object: 8 MPI processes type: bjacobi block Jacobi: number of blocks = 8 Local solve is same for all blocks, in the following KSP and PC objects: KSP Object: (sub_) 1 MPI processes type: preonly maximum iterations=10000, initial guess is zero tolerances: relative=1e-05, absolute=1e-50, divergence=10000 left preconditioning using NONE norm type for convergence test PC Object: (sub_) 1 MPI processes type: ilu ILU: out-of-place factorization 0 levels of fill tolerance for zero pivot 2.22045e-14 matrix ordering: natural factor fill ratio given 1, needed 1 Factored matrix follows: Mat Object: 1 MPI processes type: seqaij rows=46439, cols=46439 package used to perform factorization: petsc total: nonzeros=502615, allocated nonzeros=502615 total number of mallocs used during MatSetValues calls =0 not using I-node routines linear system matrix = precond matrix: Mat Object: 1 MPI processes type: seqaij rows=46439, cols=46439 total: nonzeros=502615, allocated nonzeros=504081 total number of mallocs used during MatSetValues calls =0 not using I-node routines linear system matrix = precond matrix: Mat Object: 8 MPI processes type: mpiaij rows=368656, cols=368656 total: nonzeros=4.63682e+06, allocated nonzeros=4.64417e+06 total number of mallocs used during MatSetValues calls =0 not using I-node (on process 0) routines reason,its: 2 3 0.001 1e-20 Petsc 3.7 KSP View KSP Object: 8 MPI processes type: gmres GMRES: restart=3, using Classical (unmodified) Gram-Schmidt Orthogonalization with no iterative refinement GMRES: happy breakdown tolerance 1e-30 maximum iterations=3 using preconditioner applied to right hand side for initial guess tolerances: relative=1e-08, absolute=1e-20, divergence=1e+15 left preconditioning using nonzero initial guess using PRECONDITIONED norm type for convergence test PC Object: 8 MPI processes type: bjacobi block Jacobi: number of blocks = 8 Local solve is same for all blocks, in the following KSP and PC objects: KSP Object: (sub_) 1 MPI processes type: preonly maximum iterations=10000, initial guess is zero tolerances: relative=1e-05, absolute=1e-50, divergence=10000. left preconditioning using NONE norm type for convergence test PC Object: (sub_) 1 MPI processes type: ilu ILU: out-of-place factorization 0 levels of fill tolerance for zero pivot 2.22045e-14 matrix ordering: natural factor fill ratio given 1., needed 1. Factored matrix follows: Mat Object: 1 MPI processes type: seqaij rows=46439, cols=46439 package used to perform factorization: petsc total: nonzeros=502615, allocated nonzeros=502615 total number of mallocs used during MatSetValues calls =0 not using I-node routines linear system matrix = precond matrix: Mat Object: 1 MPI processes type: seqaij rows=46439, cols=46439 total: nonzeros=502615, allocated nonzeros=504081 total number of mallocs used during MatSetValues calls =0 not using I-node routines linear system matrix = precond matrix: Mat Object: 8 MPI processes type: mpiaij rows=368656, cols=368656 total: nonzeros=4636822, allocated nonzeros=4644168 total number of mallocs used during MatSetValues calls =0 not using I-node (on process 0) routines reason,its: -11 0 0.001 1e-20 -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Fri Aug 11 12:28:43 2017 From: bsmith at mcs.anl.gov (Barry Smith) Date: Fri, 11 Aug 2017 12:28:43 -0500 Subject: [petsc-users] Petsc ILU PC Change between 3.6.4 and 3.7.x? In-Reply-To: References: Message-ID: Run with the additional option -sub_pc_factor_shift_type nonzero does this resolve the problem. We changed the default behavior for ILU when it detects "zero" pivots. Please let us know if this resolves the problem and we'll update the changes file. Barry > On Aug 11, 2017, at 12:14 PM, Gaetan Kenway wrote: > > Hi All > > I'm in the process of updating a code that uses PETSc for solving linear systems for an unstructured CFD code. As of recently, it was using an ancient version (3.3). However, when I updated it up to 3.7.6 I ended up running into issues with one of the KSP solves. The remainder of the code is identical, > I've tracked the issue down to occurring between version 3.6.4 and version 3.7.0 . The same issue is present on the most recent version 3.7.6. > > Specifically the issue is that on the second iteration, on the 3.7 version the KSP kicks out with KSP converged reason of -11 or KSP_DIVERGED_PCSETUP_FAILED . After that the two runs differ. The KSPView for each of the two are given below which are identical, up to small formatting changes. There is still more I can track down, but I thought I would ask if someone knows what might have changed between these two versions which could save me a lot of time. > > Thanks, > Gaetan > > 3.6 KSP View: > KSP Object: 8 MPI processes > type: gmres > GMRES: restart=3, using Classical (unmodified) Gram-Schmidt Orthogonalization with no iterative refinement > GMRES: happy breakdown tolerance 1e-30 > maximum iterations=3 > using preconditioner applied to right hand side for initial guess > tolerances: relative=1e-08, absolute=1e-20, divergence=1e+15 > left preconditioning > using nonzero initial guess > using PRECONDITIONED norm type for convergence test > PC Object: 8 MPI processes > type: bjacobi > block Jacobi: number of blocks = 8 > Local solve is same for all blocks, in the following KSP and PC objects: > KSP Object: (sub_) 1 MPI processes > type: preonly > maximum iterations=10000, initial guess is zero > tolerances: relative=1e-05, absolute=1e-50, divergence=10000 > left preconditioning > using NONE norm type for convergence test > PC Object: (sub_) 1 MPI processes > type: ilu > ILU: out-of-place factorization > 0 levels of fill > tolerance for zero pivot 2.22045e-14 > matrix ordering: natural > factor fill ratio given 1, needed 1 > Factored matrix follows: > Mat Object: 1 MPI processes > type: seqaij > rows=46439, cols=46439 > package used to perform factorization: petsc > total: nonzeros=502615, allocated nonzeros=502615 > total number of mallocs used during MatSetValues calls =0 > not using I-node routines > linear system matrix = precond matrix: > Mat Object: 1 MPI processes > type: seqaij > rows=46439, cols=46439 > total: nonzeros=502615, allocated nonzeros=504081 > total number of mallocs used during MatSetValues calls =0 > not using I-node routines > linear system matrix = precond matrix: > Mat Object: 8 MPI processes > type: mpiaij > rows=368656, cols=368656 > total: nonzeros=4.63682e+06, allocated nonzeros=4.64417e+06 > total number of mallocs used during MatSetValues calls =0 > not using I-node (on process 0) routines > > reason,its: 2 3 0.001 1e-20 > > > Petsc 3.7 KSP View > KSP Object: 8 MPI processes > type: gmres > GMRES: restart=3, using Classical (unmodified) Gram-Schmidt Orthogonalization with no iterative refinement > GMRES: happy breakdown tolerance 1e-30 > maximum iterations=3 > using preconditioner applied to right hand side for initial guess > tolerances: relative=1e-08, absolute=1e-20, divergence=1e+15 > left preconditioning > using nonzero initial guess > using PRECONDITIONED norm type for convergence test > PC Object: 8 MPI processes > type: bjacobi > block Jacobi: number of blocks = 8 > Local solve is same for all blocks, in the following KSP and PC objects: > KSP Object: (sub_) 1 MPI processes > type: preonly > maximum iterations=10000, initial guess is zero > tolerances: relative=1e-05, absolute=1e-50, divergence=10000. > left preconditioning > using NONE norm type for convergence test > PC Object: (sub_) 1 MPI processes > type: ilu > ILU: out-of-place factorization > 0 levels of fill > tolerance for zero pivot 2.22045e-14 > matrix ordering: natural > factor fill ratio given 1., needed 1. > Factored matrix follows: > Mat Object: 1 MPI processes > type: seqaij > rows=46439, cols=46439 > package used to perform factorization: petsc > total: nonzeros=502615, allocated nonzeros=502615 > total number of mallocs used during MatSetValues calls =0 > not using I-node routines > linear system matrix = precond matrix: > Mat Object: 1 MPI processes > type: seqaij > rows=46439, cols=46439 > total: nonzeros=502615, allocated nonzeros=504081 > total number of mallocs used during MatSetValues calls =0 > not using I-node routines > linear system matrix = precond matrix: > Mat Object: 8 MPI processes > type: mpiaij > rows=368656, cols=368656 > total: nonzeros=4636822, allocated nonzeros=4644168 > total number of mallocs used during MatSetValues calls =0 > not using I-node (on process 0) routines > > reason,its: -11 0 0.001 1e-20 > > From gaetank at gmail.com Fri Aug 11 12:47:43 2017 From: gaetank at gmail.com (Gaetan Kenway) Date: Fri, 11 Aug 2017 10:47:43 -0700 Subject: [petsc-users] Petsc ILU PC Change between 3.6.4 and 3.7.x? In-Reply-To: References: Message-ID: OK, so that was certainly it. I vaguely recall reading something about this on the mailing list at one point in time, but couldn't find anything. I would definitely put something on the 3.7 change doc since I looked there first to see if anything stuck out. Thanks! On Fri, Aug 11, 2017 at 10:28 AM, Barry Smith wrote: > > Run with the additional option > > -sub_pc_factor_shift_type nonzero > > does this resolve the problem. We changed the default behavior for ILU > when it detects "zero" pivots. > > Please let us know if this resolves the problem and we'll update the > changes file. > > Barry > > > > > On Aug 11, 2017, at 12:14 PM, Gaetan Kenway wrote: > > > > Hi All > > > > I'm in the process of updating a code that uses PETSc for solving linear > systems for an unstructured CFD code. As of recently, it was using an > ancient version (3.3). However, when I updated it up to 3.7.6 I ended up > running into issues with one of the KSP solves. The remainder of the code > is identical, > > I've tracked the issue down to occurring between version 3.6.4 and > version 3.7.0 . The same issue is present on the most recent version 3.7.6. > > > > Specifically the issue is that on the second iteration, on the 3.7 > version the KSP kicks out with KSP converged reason of -11 or > KSP_DIVERGED_PCSETUP_FAILED . After that the two runs differ. The KSPView > for each of the two are given below which are identical, up to small > formatting changes. There is still more I can track down, but I thought I > would ask if someone knows what might have changed between these two > versions which could save me a lot of time. > > > > Thanks, > > Gaetan > > > > 3.6 KSP View: > > KSP Object: 8 MPI processes > > type: gmres > > GMRES: restart=3, using Classical (unmodified) Gram-Schmidt > Orthogonalization with no iterative refinement > > GMRES: happy breakdown tolerance 1e-30 > > maximum iterations=3 > > using preconditioner applied to right hand side for initial guess > > tolerances: relative=1e-08, absolute=1e-20, divergence=1e+15 > > left preconditioning > > using nonzero initial guess > > using PRECONDITIONED norm type for convergence test > > PC Object: 8 MPI processes > > type: bjacobi > > block Jacobi: number of blocks = 8 > > Local solve is same for all blocks, in the following KSP and PC > objects: > > KSP Object: (sub_) 1 MPI processes > > type: preonly > > maximum iterations=10000, initial guess is zero > > tolerances: relative=1e-05, absolute=1e-50, divergence=10000 > > left preconditioning > > using NONE norm type for convergence test > > PC Object: (sub_) 1 MPI processes > > type: ilu > > ILU: out-of-place factorization > > 0 levels of fill > > tolerance for zero pivot 2.22045e-14 > > matrix ordering: natural > > factor fill ratio given 1, needed 1 > > Factored matrix follows: > > Mat Object: 1 MPI processes > > type: seqaij > > rows=46439, cols=46439 > > package used to perform factorization: petsc > > total: nonzeros=502615, allocated nonzeros=502615 > > total number of mallocs used during MatSetValues calls =0 > > not using I-node routines > > linear system matrix = precond matrix: > > Mat Object: 1 MPI processes > > type: seqaij > > rows=46439, cols=46439 > > total: nonzeros=502615, allocated nonzeros=504081 > > total number of mallocs used during MatSetValues calls =0 > > not using I-node routines > > linear system matrix = precond matrix: > > Mat Object: 8 MPI processes > > type: mpiaij > > rows=368656, cols=368656 > > total: nonzeros=4.63682e+06, allocated nonzeros=4.64417e+06 > > total number of mallocs used during MatSetValues calls =0 > > not using I-node (on process 0) routines > > > > reason,its: 2 3 0.001 1e-20 > > > > > > Petsc 3.7 KSP View > > KSP Object: 8 MPI processes > > type: gmres > > GMRES: restart=3, using Classical (unmodified) Gram-Schmidt > Orthogonalization with no iterative refinement > > GMRES: happy breakdown tolerance 1e-30 > > maximum iterations=3 > > using preconditioner applied to right hand side for initial guess > > tolerances: relative=1e-08, absolute=1e-20, divergence=1e+15 > > left preconditioning > > using nonzero initial guess > > using PRECONDITIONED norm type for convergence test > > PC Object: 8 MPI processes > > type: bjacobi > > block Jacobi: number of blocks = 8 > > Local solve is same for all blocks, in the following KSP and PC > objects: > > KSP Object: (sub_) 1 MPI processes > > type: preonly > > maximum iterations=10000, initial guess is zero > > tolerances: relative=1e-05, absolute=1e-50, divergence=10000. > > left preconditioning > > using NONE norm type for convergence test > > PC Object: (sub_) 1 MPI processes > > type: ilu > > ILU: out-of-place factorization > > 0 levels of fill > > tolerance for zero pivot 2.22045e-14 > > matrix ordering: natural > > factor fill ratio given 1., needed 1. > > Factored matrix follows: > > Mat Object: 1 MPI processes > > type: seqaij > > rows=46439, cols=46439 > > package used to perform factorization: petsc > > total: nonzeros=502615, allocated nonzeros=502615 > > total number of mallocs used during MatSetValues calls =0 > > not using I-node routines > > linear system matrix = precond matrix: > > Mat Object: 1 MPI processes > > type: seqaij > > rows=46439, cols=46439 > > total: nonzeros=502615, allocated nonzeros=504081 > > total number of mallocs used during MatSetValues calls =0 > > not using I-node routines > > linear system matrix = precond matrix: > > Mat Object: 8 MPI processes > > type: mpiaij > > rows=368656, cols=368656 > > total: nonzeros=4636822, allocated nonzeros=4644168 > > total number of mallocs used during MatSetValues calls =0 > > not using I-node (on process 0) routines > > > > reason,its: -11 0 0.001 1e-20 > > > > > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Fri Aug 11 14:03:15 2017 From: bsmith at mcs.anl.gov (Barry Smith) Date: Fri, 11 Aug 2017 14:03:15 -0500 Subject: [petsc-users] Petsc ILU PC Change between 3.6.4 and 3.7.x? In-Reply-To: References: Message-ID: Thanks for confirming this. The change was actually in the 3.4 release. I have updated the 3.4 changes file to include this change in both the maint and master branches. Barry > On Aug 11, 2017, at 12:47 PM, Gaetan Kenway wrote: > > OK, so that was certainly it. I vaguely recall reading something about this on the mailing list at one point in time, but couldn't find anything. > I would definitely put something on the 3.7 change doc since I looked there first to see if anything stuck out. > > Thanks! > > On Fri, Aug 11, 2017 at 10:28 AM, Barry Smith wrote: > > Run with the additional option > > -sub_pc_factor_shift_type nonzero > > does this resolve the problem. We changed the default behavior for ILU when it detects "zero" pivots. > > Please let us know if this resolves the problem and we'll update the changes file. > > Barry > > > > > On Aug 11, 2017, at 12:14 PM, Gaetan Kenway wrote: > > > > Hi All > > > > I'm in the process of updating a code that uses PETSc for solving linear systems for an unstructured CFD code. As of recently, it was using an ancient version (3.3). However, when I updated it up to 3.7.6 I ended up running into issues with one of the KSP solves. The remainder of the code is identical, > > I've tracked the issue down to occurring between version 3.6.4 and version 3.7.0 . The same issue is present on the most recent version 3.7.6. > > > > Specifically the issue is that on the second iteration, on the 3.7 version the KSP kicks out with KSP converged reason of -11 or KSP_DIVERGED_PCSETUP_FAILED . After that the two runs differ. The KSPView for each of the two are given below which are identical, up to small formatting changes. There is still more I can track down, but I thought I would ask if someone knows what might have changed between these two versions which could save me a lot of time. > > > > Thanks, > > Gaetan > > > > 3.6 KSP View: > > KSP Object: 8 MPI processes > > type: gmres > > GMRES: restart=3, using Classical (unmodified) Gram-Schmidt Orthogonalization with no iterative refinement > > GMRES: happy breakdown tolerance 1e-30 > > maximum iterations=3 > > using preconditioner applied to right hand side for initial guess > > tolerances: relative=1e-08, absolute=1e-20, divergence=1e+15 > > left preconditioning > > using nonzero initial guess > > using PRECONDITIONED norm type for convergence test > > PC Object: 8 MPI processes > > type: bjacobi > > block Jacobi: number of blocks = 8 > > Local solve is same for all blocks, in the following KSP and PC objects: > > KSP Object: (sub_) 1 MPI processes > > type: preonly > > maximum iterations=10000, initial guess is zero > > tolerances: relative=1e-05, absolute=1e-50, divergence=10000 > > left preconditioning > > using NONE norm type for convergence test > > PC Object: (sub_) 1 MPI processes > > type: ilu > > ILU: out-of-place factorization > > 0 levels of fill > > tolerance for zero pivot 2.22045e-14 > > matrix ordering: natural > > factor fill ratio given 1, needed 1 > > Factored matrix follows: > > Mat Object: 1 MPI processes > > type: seqaij > > rows=46439, cols=46439 > > package used to perform factorization: petsc > > total: nonzeros=502615, allocated nonzeros=502615 > > total number of mallocs used during MatSetValues calls =0 > > not using I-node routines > > linear system matrix = precond matrix: > > Mat Object: 1 MPI processes > > type: seqaij > > rows=46439, cols=46439 > > total: nonzeros=502615, allocated nonzeros=504081 > > total number of mallocs used during MatSetValues calls =0 > > not using I-node routines > > linear system matrix = precond matrix: > > Mat Object: 8 MPI processes > > type: mpiaij > > rows=368656, cols=368656 > > total: nonzeros=4.63682e+06, allocated nonzeros=4.64417e+06 > > total number of mallocs used during MatSetValues calls =0 > > not using I-node (on process 0) routines > > > > reason,its: 2 3 0.001 1e-20 > > > > > > Petsc 3.7 KSP View > > KSP Object: 8 MPI processes > > type: gmres > > GMRES: restart=3, using Classical (unmodified) Gram-Schmidt Orthogonalization with no iterative refinement > > GMRES: happy breakdown tolerance 1e-30 > > maximum iterations=3 > > using preconditioner applied to right hand side for initial guess > > tolerances: relative=1e-08, absolute=1e-20, divergence=1e+15 > > left preconditioning > > using nonzero initial guess > > using PRECONDITIONED norm type for convergence test > > PC Object: 8 MPI processes > > type: bjacobi > > block Jacobi: number of blocks = 8 > > Local solve is same for all blocks, in the following KSP and PC objects: > > KSP Object: (sub_) 1 MPI processes > > type: preonly > > maximum iterations=10000, initial guess is zero > > tolerances: relative=1e-05, absolute=1e-50, divergence=10000. > > left preconditioning > > using NONE norm type for convergence test > > PC Object: (sub_) 1 MPI processes > > type: ilu > > ILU: out-of-place factorization > > 0 levels of fill > > tolerance for zero pivot 2.22045e-14 > > matrix ordering: natural > > factor fill ratio given 1., needed 1. > > Factored matrix follows: > > Mat Object: 1 MPI processes > > type: seqaij > > rows=46439, cols=46439 > > package used to perform factorization: petsc > > total: nonzeros=502615, allocated nonzeros=502615 > > total number of mallocs used during MatSetValues calls =0 > > not using I-node routines > > linear system matrix = precond matrix: > > Mat Object: 1 MPI processes > > type: seqaij > > rows=46439, cols=46439 > > total: nonzeros=502615, allocated nonzeros=504081 > > total number of mallocs used during MatSetValues calls =0 > > not using I-node routines > > linear system matrix = precond matrix: > > Mat Object: 8 MPI processes > > type: mpiaij > > rows=368656, cols=368656 > > total: nonzeros=4636822, allocated nonzeros=4644168 > > total number of mallocs used during MatSetValues calls =0 > > not using I-node (on process 0) routines > > > > reason,its: -11 0 0.001 1e-20 > > > > > > From gaetank at gmail.com Fri Aug 11 14:43:41 2017 From: gaetank at gmail.com (Gaetan Kenway) Date: Fri, 11 Aug 2017 12:43:41 -0700 Subject: [petsc-users] Petsc ILU PC Change between 3.6.4 and 3.7.x? In-Reply-To: References: Message-ID: Huh. That's odd then. I was actually bisecting the petsc releases to narrow it down...I knew 3.3 was ok and 3.7 was not. So I tried 3.5 which was ok, and then 3.6 which was ok as well, leading to me to conclude the difference was between 3.6 and 3.7. On Fri, Aug 11, 2017 at 12:03 PM, Barry Smith wrote: > > Thanks for confirming this. The change was actually in the 3.4 release. > I have updated the 3.4 changes file to include this change in both the > maint and master branches. > > Barry > > > On Aug 11, 2017, at 12:47 PM, Gaetan Kenway wrote: > > > > OK, so that was certainly it. I vaguely recall reading something about > this on the mailing list at one point in time, but couldn't find anything. > > I would definitely put something on the 3.7 change doc since I looked > there first to see if anything stuck out. > > > > Thanks! > > > > On Fri, Aug 11, 2017 at 10:28 AM, Barry Smith > wrote: > > > > Run with the additional option > > > > -sub_pc_factor_shift_type nonzero > > > > does this resolve the problem. We changed the default behavior for ILU > when it detects "zero" pivots. > > > > Please let us know if this resolves the problem and we'll update the > changes file. > > > > Barry > > > > > > > > > On Aug 11, 2017, at 12:14 PM, Gaetan Kenway wrote: > > > > > > Hi All > > > > > > I'm in the process of updating a code that uses PETSc for solving > linear systems for an unstructured CFD code. As of recently, it was using > an ancient version (3.3). However, when I updated it up to 3.7.6 I ended up > running into issues with one of the KSP solves. The remainder of the code > is identical, > > > I've tracked the issue down to occurring between version 3.6.4 and > version 3.7.0 . The same issue is present on the most recent version 3.7.6. > > > > > > Specifically the issue is that on the second iteration, on the 3.7 > version the KSP kicks out with KSP converged reason of -11 or > KSP_DIVERGED_PCSETUP_FAILED . After that the two runs differ. The KSPView > for each of the two are given below which are identical, up to small > formatting changes. There is still more I can track down, but I thought I > would ask if someone knows what might have changed between these two > versions which could save me a lot of time. > > > > > > Thanks, > > > Gaetan > > > > > > 3.6 KSP View: > > > KSP Object: 8 MPI processes > > > type: gmres > > > GMRES: restart=3, using Classical (unmodified) Gram-Schmidt > Orthogonalization with no iterative refinement > > > GMRES: happy breakdown tolerance 1e-30 > > > maximum iterations=3 > > > using preconditioner applied to right hand side for initial guess > > > tolerances: relative=1e-08, absolute=1e-20, divergence=1e+15 > > > left preconditioning > > > using nonzero initial guess > > > using PRECONDITIONED norm type for convergence test > > > PC Object: 8 MPI processes > > > type: bjacobi > > > block Jacobi: number of blocks = 8 > > > Local solve is same for all blocks, in the following KSP and PC > objects: > > > KSP Object: (sub_) 1 MPI processes > > > type: preonly > > > maximum iterations=10000, initial guess is zero > > > tolerances: relative=1e-05, absolute=1e-50, divergence=10000 > > > left preconditioning > > > using NONE norm type for convergence test > > > PC Object: (sub_) 1 MPI processes > > > type: ilu > > > ILU: out-of-place factorization > > > 0 levels of fill > > > tolerance for zero pivot 2.22045e-14 > > > matrix ordering: natural > > > factor fill ratio given 1, needed 1 > > > Factored matrix follows: > > > Mat Object: 1 MPI processes > > > type: seqaij > > > rows=46439, cols=46439 > > > package used to perform factorization: petsc > > > total: nonzeros=502615, allocated nonzeros=502615 > > > total number of mallocs used during MatSetValues calls =0 > > > not using I-node routines > > > linear system matrix = precond matrix: > > > Mat Object: 1 MPI processes > > > type: seqaij > > > rows=46439, cols=46439 > > > total: nonzeros=502615, allocated nonzeros=504081 > > > total number of mallocs used during MatSetValues calls =0 > > > not using I-node routines > > > linear system matrix = precond matrix: > > > Mat Object: 8 MPI processes > > > type: mpiaij > > > rows=368656, cols=368656 > > > total: nonzeros=4.63682e+06, allocated nonzeros=4.64417e+06 > > > total number of mallocs used during MatSetValues calls =0 > > > not using I-node (on process 0) routines > > > > > > reason,its: 2 3 0.001 1e-20 > > > > > > > > > Petsc 3.7 KSP View > > > KSP Object: 8 MPI processes > > > type: gmres > > > GMRES: restart=3, using Classical (unmodified) Gram-Schmidt > Orthogonalization with no iterative refinement > > > GMRES: happy breakdown tolerance 1e-30 > > > maximum iterations=3 > > > using preconditioner applied to right hand side for initial guess > > > tolerances: relative=1e-08, absolute=1e-20, divergence=1e+15 > > > left preconditioning > > > using nonzero initial guess > > > using PRECONDITIONED norm type for convergence test > > > PC Object: 8 MPI processes > > > type: bjacobi > > > block Jacobi: number of blocks = 8 > > > Local solve is same for all blocks, in the following KSP and PC > objects: > > > KSP Object: (sub_) 1 MPI processes > > > type: preonly > > > maximum iterations=10000, initial guess is zero > > > tolerances: relative=1e-05, absolute=1e-50, divergence=10000. > > > left preconditioning > > > using NONE norm type for convergence test > > > PC Object: (sub_) 1 MPI processes > > > type: ilu > > > ILU: out-of-place factorization > > > 0 levels of fill > > > tolerance for zero pivot 2.22045e-14 > > > matrix ordering: natural > > > factor fill ratio given 1., needed 1. > > > Factored matrix follows: > > > Mat Object: 1 MPI processes > > > type: seqaij > > > rows=46439, cols=46439 > > > package used to perform factorization: petsc > > > total: nonzeros=502615, allocated nonzeros=502615 > > > total number of mallocs used during MatSetValues calls =0 > > > not using I-node routines > > > linear system matrix = precond matrix: > > > Mat Object: 1 MPI processes > > > type: seqaij > > > rows=46439, cols=46439 > > > total: nonzeros=502615, allocated nonzeros=504081 > > > total number of mallocs used during MatSetValues calls =0 > > > not using I-node routines > > > linear system matrix = precond matrix: > > > Mat Object: 8 MPI processes > > > type: mpiaij > > > rows=368656, cols=368656 > > > total: nonzeros=4636822, allocated nonzeros=4644168 > > > total number of mallocs used during MatSetValues calls =0 > > > not using I-node (on process 0) routines > > > > > > reason,its: -11 0 0.001 1e-20 > > > > > > > > > > > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Fri Aug 11 15:05:06 2017 From: bsmith at mcs.anl.gov (Barry Smith) Date: Fri, 11 Aug 2017 15:05:06 -0500 Subject: [petsc-users] Petsc ILU PC Change between 3.6.4 and 3.7.x? In-Reply-To: References: Message-ID: <4E0473C7-E67F-49EA-90CF-B6648A0CED08@mcs.anl.gov> > On Aug 11, 2017, at 2:43 PM, Gaetan Kenway wrote: > > Huh. That's odd then. I was actually bisecting the petsc releases to narrow it down...I knew 3.3 was ok and 3.7 was not. So I tried 3.5 which was ok, and then 3.6 which was ok as well, leading to me to conclude the difference was between 3.6 and 3.7. Other people have also reported only seeing the problem with later versions. I think it is related to the default tolerances and it is just "pure luck" that it didn't need a shift with the intermediate versions. ILU with nearly zero pivots is a fragile issue. Barry > > On Fri, Aug 11, 2017 at 12:03 PM, Barry Smith wrote: > > Thanks for confirming this. The change was actually in the 3.4 release. I have updated the 3.4 changes file to include this change in both the maint and master branches. > > Barry > > > On Aug 11, 2017, at 12:47 PM, Gaetan Kenway wrote: > > > > OK, so that was certainly it. I vaguely recall reading something about this on the mailing list at one point in time, but couldn't find anything. > > I would definitely put something on the 3.7 change doc since I looked there first to see if anything stuck out. > > > > Thanks! > > > > On Fri, Aug 11, 2017 at 10:28 AM, Barry Smith wrote: > > > > Run with the additional option > > > > -sub_pc_factor_shift_type nonzero > > > > does this resolve the problem. We changed the default behavior for ILU when it detects "zero" pivots. > > > > Please let us know if this resolves the problem and we'll update the changes file. > > > > Barry > > > > > > > > > On Aug 11, 2017, at 12:14 PM, Gaetan Kenway wrote: > > > > > > Hi All > > > > > > I'm in the process of updating a code that uses PETSc for solving linear systems for an unstructured CFD code. As of recently, it was using an ancient version (3.3). However, when I updated it up to 3.7.6 I ended up running into issues with one of the KSP solves. The remainder of the code is identical, > > > I've tracked the issue down to occurring between version 3.6.4 and version 3.7.0 . The same issue is present on the most recent version 3.7.6. > > > > > > Specifically the issue is that on the second iteration, on the 3.7 version the KSP kicks out with KSP converged reason of -11 or KSP_DIVERGED_PCSETUP_FAILED . After that the two runs differ. The KSPView for each of the two are given below which are identical, up to small formatting changes. There is still more I can track down, but I thought I would ask if someone knows what might have changed between these two versions which could save me a lot of time. > > > > > > Thanks, > > > Gaetan > > > > > > 3.6 KSP View: > > > KSP Object: 8 MPI processes > > > type: gmres > > > GMRES: restart=3, using Classical (unmodified) Gram-Schmidt Orthogonalization with no iterative refinement > > > GMRES: happy breakdown tolerance 1e-30 > > > maximum iterations=3 > > > using preconditioner applied to right hand side for initial guess > > > tolerances: relative=1e-08, absolute=1e-20, divergence=1e+15 > > > left preconditioning > > > using nonzero initial guess > > > using PRECONDITIONED norm type for convergence test > > > PC Object: 8 MPI processes > > > type: bjacobi > > > block Jacobi: number of blocks = 8 > > > Local solve is same for all blocks, in the following KSP and PC objects: > > > KSP Object: (sub_) 1 MPI processes > > > type: preonly > > > maximum iterations=10000, initial guess is zero > > > tolerances: relative=1e-05, absolute=1e-50, divergence=10000 > > > left preconditioning > > > using NONE norm type for convergence test > > > PC Object: (sub_) 1 MPI processes > > > type: ilu > > > ILU: out-of-place factorization > > > 0 levels of fill > > > tolerance for zero pivot 2.22045e-14 > > > matrix ordering: natural > > > factor fill ratio given 1, needed 1 > > > Factored matrix follows: > > > Mat Object: 1 MPI processes > > > type: seqaij > > > rows=46439, cols=46439 > > > package used to perform factorization: petsc > > > total: nonzeros=502615, allocated nonzeros=502615 > > > total number of mallocs used during MatSetValues calls =0 > > > not using I-node routines > > > linear system matrix = precond matrix: > > > Mat Object: 1 MPI processes > > > type: seqaij > > > rows=46439, cols=46439 > > > total: nonzeros=502615, allocated nonzeros=504081 > > > total number of mallocs used during MatSetValues calls =0 > > > not using I-node routines > > > linear system matrix = precond matrix: > > > Mat Object: 8 MPI processes > > > type: mpiaij > > > rows=368656, cols=368656 > > > total: nonzeros=4.63682e+06, allocated nonzeros=4.64417e+06 > > > total number of mallocs used during MatSetValues calls =0 > > > not using I-node (on process 0) routines > > > > > > reason,its: 2 3 0.001 1e-20 > > > > > > > > > Petsc 3.7 KSP View > > > KSP Object: 8 MPI processes > > > type: gmres > > > GMRES: restart=3, using Classical (unmodified) Gram-Schmidt Orthogonalization with no iterative refinement > > > GMRES: happy breakdown tolerance 1e-30 > > > maximum iterations=3 > > > using preconditioner applied to right hand side for initial guess > > > tolerances: relative=1e-08, absolute=1e-20, divergence=1e+15 > > > left preconditioning > > > using nonzero initial guess > > > using PRECONDITIONED norm type for convergence test > > > PC Object: 8 MPI processes > > > type: bjacobi > > > block Jacobi: number of blocks = 8 > > > Local solve is same for all blocks, in the following KSP and PC objects: > > > KSP Object: (sub_) 1 MPI processes > > > type: preonly > > > maximum iterations=10000, initial guess is zero > > > tolerances: relative=1e-05, absolute=1e-50, divergence=10000. > > > left preconditioning > > > using NONE norm type for convergence test > > > PC Object: (sub_) 1 MPI processes > > > type: ilu > > > ILU: out-of-place factorization > > > 0 levels of fill > > > tolerance for zero pivot 2.22045e-14 > > > matrix ordering: natural > > > factor fill ratio given 1., needed 1. > > > Factored matrix follows: > > > Mat Object: 1 MPI processes > > > type: seqaij > > > rows=46439, cols=46439 > > > package used to perform factorization: petsc > > > total: nonzeros=502615, allocated nonzeros=502615 > > > total number of mallocs used during MatSetValues calls =0 > > > not using I-node routines > > > linear system matrix = precond matrix: > > > Mat Object: 1 MPI processes > > > type: seqaij > > > rows=46439, cols=46439 > > > total: nonzeros=502615, allocated nonzeros=504081 > > > total number of mallocs used during MatSetValues calls =0 > > > not using I-node routines > > > linear system matrix = precond matrix: > > > Mat Object: 8 MPI processes > > > type: mpiaij > > > rows=368656, cols=368656 > > > total: nonzeros=4636822, allocated nonzeros=4644168 > > > total number of mallocs used during MatSetValues calls =0 > > > not using I-node (on process 0) routines > > > > > > reason,its: -11 0 0.001 1e-20 > > > > > > > > > > > > From gaetank at gmail.com Fri Aug 11 15:16:28 2017 From: gaetank at gmail.com (Gaetan Kenway) Date: Fri, 11 Aug 2017 13:16:28 -0700 Subject: [petsc-users] Petsc ILU PC Change between 3.6.4 and 3.7.x? In-Reply-To: <4E0473C7-E67F-49EA-90CF-B6648A0CED08@mcs.anl.gov> References: <4E0473C7-E67F-49EA-90CF-B6648A0CED08@mcs.anl.gov> Message-ID: Interesting. The main thing is it's now sorted out and then solver is back in production. Thanks for your help On Fri, Aug 11, 2017 at 1:05 PM, Barry Smith wrote: > > > On Aug 11, 2017, at 2:43 PM, Gaetan Kenway wrote: > > > > Huh. That's odd then. I was actually bisecting the petsc releases to > narrow it down...I knew 3.3 was ok and 3.7 was not. So I tried 3.5 which > was ok, and then 3.6 which was ok as well, leading to me to conclude the > difference was between 3.6 and 3.7. > > Other people have also reported only seeing the problem with later > versions. I think it is related to the default tolerances and it is just > "pure luck" that it didn't need a shift with the intermediate versions. ILU > with nearly zero pivots is a fragile issue. > > Barry > > > > > On Fri, Aug 11, 2017 at 12:03 PM, Barry Smith > wrote: > > > > Thanks for confirming this. The change was actually in the 3.4 > release. I have updated the 3.4 changes file to include this change in both > the maint and master branches. > > > > Barry > > > > > On Aug 11, 2017, at 12:47 PM, Gaetan Kenway wrote: > > > > > > OK, so that was certainly it. I vaguely recall reading something > about this on the mailing list at one point in time, but couldn't find > anything. > > > I would definitely put something on the 3.7 change doc since I looked > there first to see if anything stuck out. > > > > > > Thanks! > > > > > > On Fri, Aug 11, 2017 at 10:28 AM, Barry Smith > wrote: > > > > > > Run with the additional option > > > > > > -sub_pc_factor_shift_type nonzero > > > > > > does this resolve the problem. We changed the default behavior for ILU > when it detects "zero" pivots. > > > > > > Please let us know if this resolves the problem and we'll update the > changes file. > > > > > > Barry > > > > > > > > > > > > > On Aug 11, 2017, at 12:14 PM, Gaetan Kenway > wrote: > > > > > > > > Hi All > > > > > > > > I'm in the process of updating a code that uses PETSc for solving > linear systems for an unstructured CFD code. As of recently, it was using > an ancient version (3.3). However, when I updated it up to 3.7.6 I ended up > running into issues with one of the KSP solves. The remainder of the code > is identical, > > > > I've tracked the issue down to occurring between version 3.6.4 and > version 3.7.0 . The same issue is present on the most recent version 3.7.6. > > > > > > > > Specifically the issue is that on the second iteration, on the 3.7 > version the KSP kicks out with KSP converged reason of -11 or > KSP_DIVERGED_PCSETUP_FAILED . After that the two runs differ. The KSPView > for each of the two are given below which are identical, up to small > formatting changes. There is still more I can track down, but I thought I > would ask if someone knows what might have changed between these two > versions which could save me a lot of time. > > > > > > > > Thanks, > > > > Gaetan > > > > > > > > 3.6 KSP View: > > > > KSP Object: 8 MPI processes > > > > type: gmres > > > > GMRES: restart=3, using Classical (unmodified) Gram-Schmidt > Orthogonalization with no iterative refinement > > > > GMRES: happy breakdown tolerance 1e-30 > > > > maximum iterations=3 > > > > using preconditioner applied to right hand side for initial guess > > > > tolerances: relative=1e-08, absolute=1e-20, divergence=1e+15 > > > > left preconditioning > > > > using nonzero initial guess > > > > using PRECONDITIONED norm type for convergence test > > > > PC Object: 8 MPI processes > > > > type: bjacobi > > > > block Jacobi: number of blocks = 8 > > > > Local solve is same for all blocks, in the following KSP and PC > objects: > > > > KSP Object: (sub_) 1 MPI processes > > > > type: preonly > > > > maximum iterations=10000, initial guess is zero > > > > tolerances: relative=1e-05, absolute=1e-50, divergence=10000 > > > > left preconditioning > > > > using NONE norm type for convergence test > > > > PC Object: (sub_) 1 MPI processes > > > > type: ilu > > > > ILU: out-of-place factorization > > > > 0 levels of fill > > > > tolerance for zero pivot 2.22045e-14 > > > > matrix ordering: natural > > > > factor fill ratio given 1, needed 1 > > > > Factored matrix follows: > > > > Mat Object: 1 MPI processes > > > > type: seqaij > > > > rows=46439, cols=46439 > > > > package used to perform factorization: petsc > > > > total: nonzeros=502615, allocated nonzeros=502615 > > > > total number of mallocs used during MatSetValues calls =0 > > > > not using I-node routines > > > > linear system matrix = precond matrix: > > > > Mat Object: 1 MPI processes > > > > type: seqaij > > > > rows=46439, cols=46439 > > > > total: nonzeros=502615, allocated nonzeros=504081 > > > > total number of mallocs used during MatSetValues calls =0 > > > > not using I-node routines > > > > linear system matrix = precond matrix: > > > > Mat Object: 8 MPI processes > > > > type: mpiaij > > > > rows=368656, cols=368656 > > > > total: nonzeros=4.63682e+06, allocated nonzeros=4.64417e+06 > > > > total number of mallocs used during MatSetValues calls =0 > > > > not using I-node (on process 0) routines > > > > > > > > reason,its: 2 3 0.001 1e-20 > > > > > > > > > > > > Petsc 3.7 KSP View > > > > KSP Object: 8 MPI processes > > > > type: gmres > > > > GMRES: restart=3, using Classical (unmodified) Gram-Schmidt > Orthogonalization with no iterative refinement > > > > GMRES: happy breakdown tolerance 1e-30 > > > > maximum iterations=3 > > > > using preconditioner applied to right hand side for initial guess > > > > tolerances: relative=1e-08, absolute=1e-20, divergence=1e+15 > > > > left preconditioning > > > > using nonzero initial guess > > > > using PRECONDITIONED norm type for convergence test > > > > PC Object: 8 MPI processes > > > > type: bjacobi > > > > block Jacobi: number of blocks = 8 > > > > Local solve is same for all blocks, in the following KSP and PC > objects: > > > > KSP Object: (sub_) 1 MPI processes > > > > type: preonly > > > > maximum iterations=10000, initial guess is zero > > > > tolerances: relative=1e-05, absolute=1e-50, divergence=10000. > > > > left preconditioning > > > > using NONE norm type for convergence test > > > > PC Object: (sub_) 1 MPI processes > > > > type: ilu > > > > ILU: out-of-place factorization > > > > 0 levels of fill > > > > tolerance for zero pivot 2.22045e-14 > > > > matrix ordering: natural > > > > factor fill ratio given 1., needed 1. > > > > Factored matrix follows: > > > > Mat Object: 1 MPI processes > > > > type: seqaij > > > > rows=46439, cols=46439 > > > > package used to perform factorization: petsc > > > > total: nonzeros=502615, allocated nonzeros=502615 > > > > total number of mallocs used during MatSetValues calls =0 > > > > not using I-node routines > > > > linear system matrix = precond matrix: > > > > Mat Object: 1 MPI processes > > > > type: seqaij > > > > rows=46439, cols=46439 > > > > total: nonzeros=502615, allocated nonzeros=504081 > > > > total number of mallocs used during MatSetValues calls =0 > > > > not using I-node routines > > > > linear system matrix = precond matrix: > > > > Mat Object: 8 MPI processes > > > > type: mpiaij > > > > rows=368656, cols=368656 > > > > total: nonzeros=4636822, allocated nonzeros=4644168 > > > > total number of mallocs used during MatSetValues calls =0 > > > > not using I-node (on process 0) routines > > > > > > > > reason,its: -11 0 0.001 1e-20 > > > > > > > > > > > > > > > > > > > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From imilian.hartig at gmail.com Wed Aug 16 08:56:27 2017 From: imilian.hartig at gmail.com (Maximilian Hartig) Date: Wed, 16 Aug 2017 15:56:27 +0200 Subject: [petsc-users] accessing fields from previous, converged solution. Message-ID: <5E7F9366-B000-4F24-9E0B-9CE8BF0FA2E5@gmail.com> Hello, I have a problem with several fields that I solve with PetscFE and TS. I now need to access the solution from the previous timestep to compute the residual for the current timestep. I tried a TSMonitor with the following code in it: TSGetDM(ts,&dm); DMClone(dm,&dm_aux); DMGetDS(dm,&prob_aux); DMSetDS(dm_aux,prob_aux); DMCreateGlobalVector(dm_aux,&old_solution); VecCopy(u,oldsolution); PetscObjectCompose((PetscObject) dm, ?A?, (PetscObject) old_solution); VecDestroy(&old_solution); DMDestroy(&dm_aux); hoping that it would create an auxiliary field that I could access in the evaluation of the residual. It did that but messed with the discretisation of the initial problem in some way. So I figure that adding auxiliary fields to a dm after having fed it to a TS context is not something you should be doing. Is there a way to access the fields of the solution for the previous timestep during the evaluation of the current residual? Thanks, Max From knepley at gmail.com Wed Aug 16 09:17:52 2017 From: knepley at gmail.com (Matthew Knepley) Date: Wed, 16 Aug 2017 09:17:52 -0500 Subject: [petsc-users] accessing fields from previous, converged solution. In-Reply-To: <5E7F9366-B000-4F24-9E0B-9CE8BF0FA2E5@gmail.com> References: <5E7F9366-B000-4F24-9E0B-9CE8BF0FA2E5@gmail.com> Message-ID: On Wed, Aug 16, 2017 at 8:56 AM, Maximilian Hartig wrote: > Hello, > > I have a problem with several fields that I solve with PetscFE and TS. I > now need to access the solution from the previous timestep to compute the > residual for the current timestep. > I tried a TSMonitor with the following code in it: > > TSGetDM(ts,&dm); > DMClone(dm,&dm_aux); > DMGetDS(dm,&prob_aux); > DMSetDS(dm_aux,prob_aux); > DMCreateGlobalVector(dm_aux,&old_solution); > VecCopy(u,oldsolution); > PetscObjectCompose((PetscObject) dm, ?A?, (PetscObject) old_solution); > > VecDestroy(&old_solution); > DMDestroy(&dm_aux); > > hoping that it would create an auxiliary field that I could access in the > evaluation of the residual. It did that but messed with the discretisation > of the initial problem in some way. So I figure that adding auxiliary > fields to a dm after having fed it to a TS context is not something you > should be doing. > > Is there a way to access the fields of the solution for the previous > timestep during the evaluation of the current residual? > First, I can show you how to do what you are asking for. I think you can simply PetscObjectQuery((PetscObject) dm, "old_solution", (PetscObject *) &old_solution); if (!old_solution) { DMCreateGlobalVector(dm, &old_solution); PetscObjectCompose((PetscObject) dm, "old_solution", old_solution); } VecCopy(u, oldsolution); Second, I think a better way to do this than composition is to use DMGetNamedGlobalVector(dm, "old_solution", &old_solution); Third, I can say that I am profoundly troubled by this. This interferes with the operation of the time integrator, and I cannot see a reason for this. If you are keeping track of the integral of some quantity, I would update that in TSPostStep() and request that integral instead of the previous solution. We do this for some non-Newtonian rheologies. Thanks, Matt > Thanks, > Max -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener http://www.caam.rice.edu/~mk51/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From rachitp at vt.edu Wed Aug 16 10:01:32 2017 From: rachitp at vt.edu (Rachit Prasad) Date: Wed, 16 Aug 2017 11:01:32 -0400 Subject: [petsc-users] Query regarding old PETSC version Message-ID: Hi, Due to legacy issues, I am working with tversion 2.3.2 of PETSc in FORTRAN. I want to monitor the true residual and hence I tried to use the function KSPTrueResididual(). However, I am unable to understand what kind of pointer is the last input parameter, "*dummy" supposed to be. I could not find an example on the website since this is an older implementation. Any insight on how to proceed further will be greatly helpful. Regards, Rachit -------------- next part -------------- An HTML attachment was scrubbed... URL: From knepley at gmail.com Wed Aug 16 10:05:24 2017 From: knepley at gmail.com (Matthew Knepley) Date: Wed, 16 Aug 2017 10:05:24 -0500 Subject: [petsc-users] Query regarding old PETSC version In-Reply-To: References: Message-ID: On Wed, Aug 16, 2017 at 10:01 AM, Rachit Prasad wrote: > Hi, > > Due to legacy issues, I am working with tversion 2.3.2 of PETSc in > FORTRAN. I want to monitor the true residual and hence I tried to use the > function KSPTrueResididual(). However, I am unable to understand what kind > of pointer is the last input parameter, "*dummy" supposed to be. I could > not find an example on the website since this is an older implementation. > Any insight on how to proceed further will be greatly helpful. > That is a very long time ago, but I think you can use PETSC_NULL_OBJECT (if it exists). Also -ksp_monitor_true_residual may work. Thanks, Matt > Regards, > Rachit > > -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener http://www.caam.rice.edu/~mk51/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From balay at mcs.anl.gov Wed Aug 16 10:11:48 2017 From: balay at mcs.anl.gov (Satish Balay) Date: Wed, 16 Aug 2017 10:11:48 -0500 Subject: [petsc-users] Query regarding old PETSC version In-Reply-To: References: Message-ID: neither of these appear to be in petsc-2.3.2 balay at es^/sandbox/balay/tmp/petsc-2.3.2-p10 $ grep -ri true_residual . balay at es^/sandbox/balay/tmp/petsc-2.3.2-p10 $ grep -ri KSPTrueResididual . balay at es^/sandbox/balay/tmp/petsc-2.3.2-p10 $ Satish On Wed, 16 Aug 2017, Matthew Knepley wrote: > On Wed, Aug 16, 2017 at 10:01 AM, Rachit Prasad wrote: > > > Hi, > > > > Due to legacy issues, I am working with tversion 2.3.2 of PETSc in > > FORTRAN. I want to monitor the true residual and hence I tried to use the > > function KSPTrueResididual(). However, I am unable to understand what kind > > of pointer is the last input parameter, "*dummy" supposed to be. I could > > not find an example on the website since this is an older implementation. > > Any insight on how to proceed further will be greatly helpful. > > > > That is a very long time ago, but I think you can use PETSC_NULL_OBJECT (if > it exists). Also > -ksp_monitor_true_residual may work. > > Thanks, > > Matt > > > > Regards, > > Rachit > > > > > > > From balay at mcs.anl.gov Wed Aug 16 10:22:18 2017 From: balay at mcs.anl.gov (Satish Balay) Date: Wed, 16 Aug 2017 10:22:18 -0500 Subject: [petsc-users] Query regarding old PETSC version In-Reply-To: References: Message-ID: balay at es^/sandbox/balay/tmp/petsc-2.3.2-p10 $ grep KSPTrueMonitor include/petscksp.h EXTERN PetscErrorCode PETSCKSP_DLLEXPORT KSPTrueMonitor(KSP,PetscInt,PetscReal,void *); https://www.mcs.anl.gov/petsc/documentation/changes/233.html The following function names are changed to be consistant: KSPTrueMonitor -> KSPMonitorTrueResidualNorm src/ksp/ksp/interface/ftn-custom/zitfuncf.c has: void ksptruemonitor_(KSP *ksp,PetscInt *it,PetscReal *norm,void *ctx,PetscErrorCode *ierr) { *ierr = KSPTrueMonitor(*ksp,*it,*norm,ctx); } For PETSC_NULL_OBJECT to work - you might have to change it to: void ksptruemonitor_(KSP *ksp,PetscInt *it,PetscReal *norm,void *ctx,PetscErrorCode *ierr) { CHKFORTRANNULLOBJECT(ctx); *ierr = KSPTrueMonitor(*ksp,*it,*norm,ctx); } Satish On Wed, 16 Aug 2017, Satish Balay wrote: > neither of these appear to be in petsc-2.3.2 > > balay at es^/sandbox/balay/tmp/petsc-2.3.2-p10 $ grep -ri true_residual . > balay at es^/sandbox/balay/tmp/petsc-2.3.2-p10 $ grep -ri KSPTrueResididual . > balay at es^/sandbox/balay/tmp/petsc-2.3.2-p10 $ > > Satish > > > On Wed, 16 Aug 2017, Matthew Knepley wrote: > > > On Wed, Aug 16, 2017 at 10:01 AM, Rachit Prasad wrote: > > > > > Hi, > > > > > > Due to legacy issues, I am working with tversion 2.3.2 of PETSc in > > > FORTRAN. I want to monitor the true residual and hence I tried to use the > > > function KSPTrueResididual(). However, I am unable to understand what kind > > > of pointer is the last input parameter, "*dummy" supposed to be. I could > > > not find an example on the website since this is an older implementation. > > > Any insight on how to proceed further will be greatly helpful. > > > > > > > That is a very long time ago, but I think you can use PETSC_NULL_OBJECT (if > > it exists). Also > > -ksp_monitor_true_residual may work. > > > > Thanks, > > > > Matt > > > > > > > Regards, > > > Rachit > > > > > > > > > > > > > > From fande.kong at inl.gov Wed Aug 16 14:36:24 2017 From: fande.kong at inl.gov (Kong, Fande) Date: Wed, 16 Aug 2017 13:36:24 -0600 Subject: [petsc-users] EPS monitor Message-ID: Hi All, How to understand the following messages: 1 EPS nconv=0 first unconverged value (error) 2.06312 (3.29164033e-01) 2 EPS nconv=0 first unconverged value (error) 2.03951 (1.76223074e-01) 3 EPS nconv=0 first unconverged value (error) 2.01177 (5.71109559e-02) 4 EPS nconv=0 first unconverged value (error) 2.01042 (4.84609300e-02) 5 EPS nconv=0 first unconverged value (error) 2.00708 (3.19917457e-02) 6 EPS nconv=0 first unconverged value (error) 2.00595 (2.62792109e-02) 7 EPS nconv=0 first unconverged value (error) 2.00504 (2.13766150e-02) 8 EPS nconv=0 first unconverged value (error) 2.00441 (1.85066774e-02) 9 EPS nconv=0 first unconverged value (error) 2.00397 (1.73188449e-02) 10 EPS nconv=0 first unconverged value (error) 2.00366 (1.54528517e-02) 11 EPS nconv=0 first unconverged value (error) 2.00339 (1.32215899e-02) 12 EPS nconv=0 first unconverged value (error) 2.00316 (1.32215899e-02) 13 EPS nconv=0 first unconverged value (error) 2.00316 (1.17928920e-02) 14 EPS nconv=0 first unconverged value (error) 2.00297 (1.04964387e-02) 15 EPS nconv=0 first unconverged value (error) 2.0028 (9.58244972e-03) 16 EPS nconv=0 first unconverged value (error) 2.00268 (9.06634973e-03) 17 EPS nconv=0 first unconverged value (error) 2.00198 (3.43444441e-04) 18 EPS nconv=1 first unconverged value (error) 2.25718 (1.79769313e+308) 18 EPS converged value (error) #0 2.00197 (5.69451918e-09) When the solver converged, the wrong eigenvalue and the wrong residual are printed out. Do we design like this way? Fande, -------------- next part -------------- An HTML attachment was scrubbed... URL: From jroman at dsic.upv.es Wed Aug 16 15:12:19 2017 From: jroman at dsic.upv.es (Jose E. Roman) Date: Wed, 16 Aug 2017 22:12:19 +0200 Subject: [petsc-users] EPS monitor In-Reply-To: References: Message-ID: <3FB57FBE-D8B4-4A2E-97B1-0DDA15846787@dsic.upv.es> > El 16 ago 2017, a las 21:36, Kong, Fande escribi?: > > Hi All, > > How to understand the following messages: > > 1 EPS nconv=0 first unconverged value (error) 2.06312 (3.29164033e-01) > 2 EPS nconv=0 first unconverged value (error) 2.03951 (1.76223074e-01) > 3 EPS nconv=0 first unconverged value (error) 2.01177 (5.71109559e-02) > 4 EPS nconv=0 first unconverged value (error) 2.01042 (4.84609300e-02) > 5 EPS nconv=0 first unconverged value (error) 2.00708 (3.19917457e-02) > 6 EPS nconv=0 first unconverged value (error) 2.00595 (2.62792109e-02) > 7 EPS nconv=0 first unconverged value (error) 2.00504 (2.13766150e-02) > 8 EPS nconv=0 first unconverged value (error) 2.00441 (1.85066774e-02) > 9 EPS nconv=0 first unconverged value (error) 2.00397 (1.73188449e-02) > 10 EPS nconv=0 first unconverged value (error) 2.00366 (1.54528517e-02) > 11 EPS nconv=0 first unconverged value (error) 2.00339 (1.32215899e-02) > 12 EPS nconv=0 first unconverged value (error) 2.00316 (1.32215899e-02) > 13 EPS nconv=0 first unconverged value (error) 2.00316 (1.17928920e-02) > 14 EPS nconv=0 first unconverged value (error) 2.00297 (1.04964387e-02) > 15 EPS nconv=0 first unconverged value (error) 2.0028 (9.58244972e-03) > 16 EPS nconv=0 first unconverged value (error) 2.00268 (9.06634973e-03) > 17 EPS nconv=0 first unconverged value (error) 2.00198 (3.43444441e-04) > 18 EPS nconv=1 first unconverged value (error) 2.25718 (1.79769313e+308) > 18 EPS converged value (error) #0 2.00197 (5.69451918e-09) > > > When the solver converged, the wrong eigenvalue and the wrong residual are printed out. Do we design like this way? > > Fande, Is this the POWER solver? Most solvers in EPS approximate several eigenvalues simultaneously, but this is not the case in POWER - when one eigenvalue converges there is no approximation available for the next one. I will think about a simple fix. Jose From fande.kong at inl.gov Wed Aug 16 15:19:23 2017 From: fande.kong at inl.gov (Kong, Fande) Date: Wed, 16 Aug 2017 14:19:23 -0600 Subject: [petsc-users] EPS monitor In-Reply-To: <3FB57FBE-D8B4-4A2E-97B1-0DDA15846787@dsic.upv.es> References: <3FB57FBE-D8B4-4A2E-97B1-0DDA15846787@dsic.upv.es> Message-ID: Solver details: EPS Object: 1 MPI processes type: jd search subspace is orthogonalized block size=1 type of the initial subspace: non-Krylov size of the subspace after restarting: 6 number of vectors after restarting from the previous iteration: 1 problem type: generalized non-symmetric eigenvalue problem extraction type: harmonic Ritz selected portion of the spectrum: smallest eigenvalues in magnitude number of eigenvalues (nev): 1 number of column vectors (ncv): 18 maximum dimension of projected problem (mpd): 18 maximum number of iterations: 10000 tolerance: 0.0001 convergence test: relative to the eigenvalue BV Object: 1 MPI processes type: svec 18 columns of global length 4225 vector orthogonalization method: classical Gram-Schmidt orthogonalization refinement: if needed (eta: 0.7071) block orthogonalization method: Gram-Schmidt doing matmult as a single matrix-matrix product DS Object: 1 MPI processes type: gnhep ST Object: 1 MPI processes type: precond shift: 0. number of matrices: 2 all matrices have different nonzero pattern KSP Object: (st_) 1 MPI processes type: bcgsl Ell = 2 Delta = 0 maximum iterations=10000, initial guess is zero tolerances: relative=1e-05, absolute=1e-50, divergence=10000. left preconditioning using PRECONDITIONED norm type for convergence test PC Object: (st_) 1 MPI processes type: jacobi linear system matrix = precond matrix: Mat Object: () 1 MPI processes type: seqaij rows=4225, cols=4225 total: nonzeros=37249, allocated nonzeros=37249 total number of mallocs used during MatSetValues calls =0 not using I-node routines On Wed, Aug 16, 2017 at 2:12 PM, Jose E. Roman wrote: > > > El 16 ago 2017, a las 21:36, Kong, Fande escribi?: > > > > Hi All, > > > > How to understand the following messages: > > > > 1 EPS nconv=0 first unconverged value (error) 2.06312 (3.29164033e-01) > > 2 EPS nconv=0 first unconverged value (error) 2.03951 (1.76223074e-01) > > 3 EPS nconv=0 first unconverged value (error) 2.01177 (5.71109559e-02) > > 4 EPS nconv=0 first unconverged value (error) 2.01042 (4.84609300e-02) > > 5 EPS nconv=0 first unconverged value (error) 2.00708 (3.19917457e-02) > > 6 EPS nconv=0 first unconverged value (error) 2.00595 (2.62792109e-02) > > 7 EPS nconv=0 first unconverged value (error) 2.00504 (2.13766150e-02) > > 8 EPS nconv=0 first unconverged value (error) 2.00441 (1.85066774e-02) > > 9 EPS nconv=0 first unconverged value (error) 2.00397 (1.73188449e-02) > > 10 EPS nconv=0 first unconverged value (error) 2.00366 (1.54528517e-02) > > 11 EPS nconv=0 first unconverged value (error) 2.00339 (1.32215899e-02) > > 12 EPS nconv=0 first unconverged value (error) 2.00316 (1.32215899e-02) > > 13 EPS nconv=0 first unconverged value (error) 2.00316 (1.17928920e-02) > > 14 EPS nconv=0 first unconverged value (error) 2.00297 (1.04964387e-02) > > 15 EPS nconv=0 first unconverged value (error) 2.0028 (9.58244972e-03) > > 16 EPS nconv=0 first unconverged value (error) 2.00268 (9.06634973e-03) > > 17 EPS nconv=0 first unconverged value (error) 2.00198 (3.43444441e-04) > > 18 EPS nconv=1 first unconverged value (error) 2.25718 (1.79769313e+308) > > 18 EPS converged value (error) #0 2.00197 (5.69451918e-09) > > > > > > When the solver converged, the wrong eigenvalue and the wrong residual > are printed out. Do we design like this way? > > > > Fande, > > Is this the POWER solver? Most solvers in EPS approximate several > eigenvalues simultaneously, but this is not the case in POWER - when one > eigenvalue converges there is no approximation available for the next one. > > I will think about a simple fix. > > Jose > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From imilian.hartig at gmail.com Thu Aug 17 03:13:23 2017 From: imilian.hartig at gmail.com (Maximilian Hartig) Date: Thu, 17 Aug 2017 10:13:23 +0200 Subject: [petsc-users] accessing fields from previous, converged solution. In-Reply-To: References: <5E7F9366-B000-4F24-9E0B-9CE8BF0FA2E5@gmail.com> Message-ID: Thanks for your help Matt. > On 16. Aug 2017, at 16:17, Matthew Knepley wrote: > > On Wed, Aug 16, 2017 at 8:56 AM, Maximilian Hartig > wrote: > Hello, > > I have a problem with several fields that I solve with PetscFE and TS. I now need to access the solution from the previous timestep to compute the residual for the current timestep. > I tried a TSMonitor with the following code in it: > > TSGetDM(ts,&dm); > DMClone(dm,&dm_aux); > DMGetDS(dm,&prob_aux); > DMSetDS(dm_aux,prob_aux); > DMCreateGlobalVector(dm_aux,&old_solution); > VecCopy(u,oldsolution); > PetscObjectCompose((PetscObject) dm, ?A?, (PetscObject) old_solution); > > VecDestroy(&old_solution); > DMDestroy(&dm_aux); > > hoping that it would create an auxiliary field that I could access in the evaluation of the residual. It did that but messed with the discretisation of the initial problem in some way. So I figure that adding auxiliary fields to a dm after having fed it to a TS context is not something you should be doing. > > Is there a way to access the fields of the solution for the previous timestep during the evaluation of the current residual? > > First, I can show you how to do what you are asking for. I think you can simply > > PetscObjectQuery((PetscObject) dm, "old_solution", (PetscObject *) &old_solution); > if (!old_solution) { > DMCreateGlobalVector(dm, &old_solution); > PetscObjectCompose((PetscObject) dm, "old_solution", old_solution); > } > VecCopy(u, oldsolution); Unfortunately, this produces an error and tells me ?An object cannot be composed with an object that was composed with it." > > Second, I think a better way to do this than composition is to use > > DMGetNamedGlobalVector(dm, "old_solution", &old_solution); Yes, this seems to work and I do not get an error while running the monitor. Also the discretisation seems to be fine. But the old solution now is not available as an auxiliary field. > > Third, I can say that I am profoundly troubled by this. This interferes with the operation of > the time integrator, and I cannot see a reason for this. If you are keeping track of the integral > of some quantity, I would update that in TSPostStep() and request that integral instead of the > previous solution. We do this for some non-Newtonian rheologies. I have an ?if? condition in my residual which I need to evaluate to determine the correct formulation for my residuals. I use actual fields to keep track of the integrals. But when I use the actual field to evaluate the ?if? condition, due to the implicit nature of the solver I jump ?back and forth? over that condition. I need the ?if? condition to be independent from the field for which it determines the residual. The actual application is as follows: I have, amongst others, a displacement and a stress field. I evaluate for my stress given a displacement increment delta u. If the resulting stress is > yield stress, I need a plasticity formulation, if it is smaller, I can use elasticity. Thanks, Max > > Thanks, > > Matt > > Thanks, > Max > > > > -- > What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. > -- Norbert Wiener > > http://www.caam.rice.edu/~mk51/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From knepley at gmail.com Thu Aug 17 06:51:36 2017 From: knepley at gmail.com (Matthew Knepley) Date: Thu, 17 Aug 2017 06:51:36 -0500 Subject: [petsc-users] accessing fields from previous, converged solution. In-Reply-To: References: <5E7F9366-B000-4F24-9E0B-9CE8BF0FA2E5@gmail.com> Message-ID: On Thu, Aug 17, 2017 at 3:13 AM, Maximilian Hartig wrote: > Thanks for your help Matt. > > On 16. Aug 2017, at 16:17, Matthew Knepley wrote: > > On Wed, Aug 16, 2017 at 8:56 AM, Maximilian Hartig com> wrote: > >> Hello, >> >> I have a problem with several fields that I solve with PetscFE and TS. I >> now need to access the solution from the previous timestep to compute the >> residual for the current timestep. >> I tried a TSMonitor with the following code in it: >> >> TSGetDM(ts,&dm); >> DMClone(dm,&dm_aux); >> DMGetDS(dm,&prob_aux); >> DMSetDS(dm_aux,prob_aux); >> DMCreateGlobalVector(dm_aux,&old_solution); >> VecCopy(u,oldsolution); >> PetscObjectCompose((PetscObject) dm, ?A?, (PetscObject) old_solution); >> >> VecDestroy(&old_solution); >> DMDestroy(&dm_aux); >> >> hoping that it would create an auxiliary field that I could access in the >> evaluation of the residual. It did that but messed with the discretisation >> of the initial problem in some way. So I figure that adding auxiliary >> fields to a dm after having fed it to a TS context is not something you >> should be doing. >> >> Is there a way to access the fields of the solution for the previous >> timestep during the evaluation of the current residual? >> > > First, I can show you how to do what you are asking for. I think you can > simply > > PetscObjectQuery((PetscObject) dm, "old_solution", (PetscObject *) > &old_solution); > if (!old_solution) { > DMCreateGlobalVector(dm, &old_solution); > PetscObjectCompose((PetscObject) dm, "old_solution", old_solution); > } > VecCopy(u, oldsolution); > > > Unfortunately, this produces an error and tells me ?An object cannot be > composed with an object that was composed with it." > > > Second, I think a better way to do this than composition is to use > > DMGetNamedGlobalVector(dm, "old_solution", &old_solution); > > > Yes, this seems to work and I do not get an error while running the > monitor. Also the discretisation seems to be fine. But the old solution now > is not available as an auxiliary field. > > > Third, I can say that I am profoundly troubled by this. This interferes > with the operation of > the time integrator, and I cannot see a reason for this. If you are > keeping track of the integral > of some quantity, I would update that in TSPostStep() and request that > integral instead of the > previous solution. We do this for some non-Newtonian rheologies. > > > I have an ?if? condition in my residual which I need to evaluate to > determine the correct formulation for my residuals. I use actual fields to > keep track of the integrals. But when I use the actual field to evaluate > the ?if? condition, due to the implicit nature of the solver I jump ?back > and forth? over that condition. I need the ?if? condition to be independent > from the field for which it determines the residual. > The actual application is as follows: > I have, amongst others, a displacement and a stress field. > I evaluate for my stress given a displacement increment delta u. > If the resulting stress is > yield stress, I need a plasticity > formulation, if it is smaller, I can use elasticity. > Hmm, I think this is a formulation problem. You should be using the "correct" formulation at the implicit step, since otherwise the residual will be inconsistent with what you tested when evaluated at the new step. I have the same kind of elasto-plastic system in PyLith (http://www.geodynamics.org/cig/software/pylith/) which we solve implicitly without much problem. Thanks, Matt > Thanks, > Max > > > Thanks, > > Matt > > >> Thanks, >> Max > > > > > -- > What most experimenters take for granted before they begin their > experiments is infinitely more interesting than any results to which their > experiments lead. > -- Norbert Wiener > > http://www.caam.rice.edu/~mk51/ > > > -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener http://www.caam.rice.edu/~mk51/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From M.Parkinson at bath.ac.uk Sun Aug 20 12:23:41 2017 From: M.Parkinson at bath.ac.uk (Matthew Parkinson) Date: Sun, 20 Aug 2017 17:23:41 +0000 Subject: [petsc-users] PETSC Makefile Problems in Fortran Message-ID: <1503249823487.43449@bath.ac.uk> Dear Sir / Madam, I am having some trouble setting up a (basic) Makefile to use the PETSC codes. I have attempted to follow the various manuals and online resources, however I am clearly missing something. Could you possibly help me? The details are: Compiler: F95 (Fortran) PETSC Directory is: /home/t/mp826/phd/petsc/ I am then trying to run a simple "Hello world" program, entitled main.f90, that constructs a PETSC Vec datatype (but does not use it). The main.f90 file is stored in the directory: /home/t/mp826/phd/test_petsc/. Any help would be very much appreciated. Kind Regards, Matthew Parkinson -------------- next part -------------- An HTML attachment was scrubbed... URL: From balay at mcs.anl.gov Sun Aug 20 12:38:39 2017 From: balay at mcs.anl.gov (Satish Balay) Date: Sun, 20 Aug 2017 12:38:39 -0500 Subject: [petsc-users] PETSC Makefile Problems in Fortran In-Reply-To: <1503249823487.43449@bath.ac.uk> References: <1503249823487.43449@bath.ac.uk> Message-ID: PETSc requires fortran preprocessing - so you should rename your file as .F90 And you should be able to copy an example makefile (say src/ksp/ksp/examples/tutorials) - and modify it as needed ( i.e modify target 'ex1f' to 'main') Satish On Sun, 20 Aug 2017, Matthew Parkinson wrote: > Dear Sir / Madam, > > > I am having some trouble setting up a (basic) Makefile to use the PETSC codes. I have attempted to follow the various manuals and online resources, however I am clearly missing something. Could you possibly help me? > > > The details are: > > Compiler: F95 (Fortran) > > PETSC Directory is: /home/t/mp826/phd/petsc/ > > > I am then trying to run a simple "Hello world" program, entitled main.f90, that constructs a PETSC Vec datatype (but does not use it). The main.f90 file is stored in the directory: /home/t/mp826/phd/test_petsc/. > > > Any help would be very much appreciated. > > Kind Regards, > Matthew Parkinson > From bcyee at umich.edu Mon Aug 21 13:58:51 2017 From: bcyee at umich.edu (Ben Yee) Date: Mon, 21 Aug 2017 14:58:51 -0400 Subject: [petsc-users] Which type of matrix do I use to define my own interpolation operators in PCMG? Message-ID: Hi, I was wondering what type of matrix I should use if I want to define my own interpolation matrix in PCMG. I don't have any DM objects, and I wanted to provide the matrix entries to the interpolation matrix manually. Moreover, I want the coarse grid operators to be defined via the Galerkin process, so I only need to define the interpolation operator. The fine grid problem/operator is defined as a parallel sparse matrix using MATMPIAIJ. My interpolation operator is also parallel and sparse -- does that mean I should also use MATMPIAIJ for my interpolation operator? I did some digging but I couldn't find any examples where the interpolation/restriction operators in PETSc were defined explicitly by the user. I also found the documentation for the matrix type MATMAIJ ( http://www.mcs.anl.gov/petsc/petsc-current/docs/ manualpages/Mat/MATMAIJ.html#MATMAIJ), which indicates that it is a specialized matrix for interpolation/restriction operations. However, I also noticed that the description for MATMAIJ indicates that it will interpolate each component the same way independently. I do have a multicomponent problem, but I was hoping to interpolate each component differently -- does that mean I can't use the MATMAIJ matrix type? If it is recommended that I use the MATMAIJ matrix type, I would like some clarification regarding the MatCreateMAIJ function. In particular, I'm not really sure how the input matrix "A" (first argument of MatCreateMAIJ) is supposed to be -- the description of MatCreateMAIJ says "the AIJ matrix describing the action on blocks," but I don't know what that means. The use of MatCreateMAIJ in ex48.c is not really clear to me. Any guidance would be much appreciated. Thanks! -- Ben Yee NERS PhD Candidate, University of Michigan B.S. Mech. & Nuclear Eng., U.C. Berkeley -------------- next part -------------- An HTML attachment was scrubbed... URL: From jed at jedbrown.org Mon Aug 21 17:00:24 2017 From: jed at jedbrown.org (Jed Brown) Date: Mon, 21 Aug 2017 15:00:24 -0700 Subject: [petsc-users] Which type of matrix do I use to define my own interpolation operators in PCMG? In-Reply-To: References: Message-ID: <87k21wd1jb.fsf@jedbrown.org> Ben Yee writes: > Hi, > > I was wondering what type of matrix I should use if I want to define my own > interpolation matrix in PCMG. > > I don't have any DM objects, and I wanted to provide the matrix entries to > the interpolation matrix manually. Moreover, I want the coarse grid > operators to be defined via the Galerkin process, so I only need to define > the interpolation operator. The fine grid problem/operator is defined as a > parallel sparse matrix using MATMPIAIJ. My interpolation operator is also > parallel and sparse -- does that mean I should also use MATMPIAIJ for my > interpolation operator? > > I did some digging but I couldn't find any examples where the > interpolation/restriction operators in PETSc were defined explicitly by the > user. src/ksp/pc/examples/tests/ex5.c > I also found the documentation for the matrix type MATMAIJ ( > http://www.mcs.anl.gov/petsc/petsc-current/docs/ > manualpages/Mat/MATMAIJ.html#MATMAIJ), which indicates that it is a > specialized matrix for interpolation/restriction operations. However, > I also noticed that the description for MATMAIJ indicates that it will > interpolate each component the same way independently. I do have a > multicomponent problem, but I was hoping to interpolate each component > differently -- does that mean I can't use the MATMAIJ matrix type? Correct, MAIJ applies the Kronecker product of a scalar interpolation with the identity so it acts the same on each component. It's more efficient if you want each component treated the same way. > If it is recommended that I use the MATMAIJ matrix type, I would like some > clarification regarding the MatCreateMAIJ function. In particular, I'm not > really sure how the input matrix "A" (first argument of MatCreateMAIJ) is > supposed to be -- the description of MatCreateMAIJ says "the AIJ matrix > describing the action on blocks," but I don't know what that means. The > use of MatCreateMAIJ in ex48.c is not really clear to me. > > Any guidance would be much appreciated. Thanks! > > -- > Ben Yee > > NERS PhD Candidate, University of Michigan > B.S. Mech. & Nuclear Eng., U.C. Berkeley -------------- next part -------------- A non-text attachment was scrubbed... Name: signature.asc Type: application/pgp-signature Size: 832 bytes Desc: not available URL: From imilian.hartig at gmail.com Tue Aug 22 06:52:30 2017 From: imilian.hartig at gmail.com (Maximilian Hartig) Date: Tue, 22 Aug 2017 13:52:30 +0200 Subject: [petsc-users] accessing fields from previous, converged solution. In-Reply-To: References: <5E7F9366-B000-4F24-9E0B-9CE8BF0FA2E5@gmail.com> Message-ID: <9056F8CB-FAAC-4B63-B498-FDD84C9EC2DF@gmail.com> > On 17. Aug 2017, at 13:51, Matthew Knepley wrote: > > On Thu, Aug 17, 2017 at 3:13 AM, Maximilian Hartig > wrote: > Thanks for your help Matt. >> On 16. Aug 2017, at 16:17, Matthew Knepley > wrote: >> >> On Wed, Aug 16, 2017 at 8:56 AM, Maximilian Hartig > wrote: >> Hello, >> >> I have a problem with several fields that I solve with PetscFE and TS. I now need to access the solution from the previous timestep to compute the residual for the current timestep. >> I tried a TSMonitor with the following code in it: >> >> TSGetDM(ts,&dm); >> DMClone(dm,&dm_aux); >> DMGetDS(dm,&prob_aux); >> DMSetDS(dm_aux,prob_aux); >> DMCreateGlobalVector(dm_aux,&old_solution); >> VecCopy(u,oldsolution); >> PetscObjectCompose((PetscObject) dm, ?A?, (PetscObject) old_solution); >> >> VecDestroy(&old_solution); >> DMDestroy(&dm_aux); >> >> hoping that it would create an auxiliary field that I could access in the evaluation of the residual. It did that but messed with the discretisation of the initial problem in some way. So I figure that adding auxiliary fields to a dm after having fed it to a TS context is not something you should be doing. >> >> Is there a way to access the fields of the solution for the previous timestep during the evaluation of the current residual? >> >> First, I can show you how to do what you are asking for. I think you can simply >> >> PetscObjectQuery((PetscObject) dm, "old_solution", (PetscObject *) &old_solution); >> if (!old_solution) { >> DMCreateGlobalVector(dm, &old_solution); >> PetscObjectCompose((PetscObject) dm, "old_solution", old_solution); >> } >> VecCopy(u, oldsolution); > > Unfortunately, this produces an error and tells me ?An object cannot be composed with an object that was composed with it." > >> >> Second, I think a better way to do this than composition is to use >> >> DMGetNamedGlobalVector(dm, "old_solution", &old_solution); > > Yes, this seems to work and I do not get an error while running the monitor. Also the discretisation seems to be fine. But the old solution now is not available as an auxiliary field. > >> >> Third, I can say that I am profoundly troubled by this. This interferes with the operation of >> the time integrator, and I cannot see a reason for this. If you are keeping track of the integral >> of some quantity, I would update that in TSPostStep() and request that integral instead of the >> previous solution. We do this for some non-Newtonian rheologies. > > I have an ?if? condition in my residual which I need to evaluate to determine the correct formulation for my residuals. I use actual fields to keep track of the integrals. But when I use the actual field to evaluate the ?if? condition, due to the implicit nature of the solver I jump ?back and forth? over that condition. I need the ?if? condition to be independent from the field for which it determines the residual. > The actual application is as follows: > I have, amongst others, a displacement and a stress field. > I evaluate for my stress given a displacement increment delta u. > If the resulting stress is > yield stress, I need a plasticity formulation, if it is smaller, I can use elasticity. > > Hmm, I think this is a formulation problem. You should be using the "correct" formulation at the implicit step, since otherwise > the residual will be inconsistent with what you tested when evaluated at the new step. I have the same kind of elasto-plastic > system in PyLith (http://www.geodynamics.org/cig/software/pylith/ ) which we solve implicitly without much problem. Possible, but I rechecked the formulation and it looks fine to me. In literature, this kind of algorithm uses an elastic predictor step to determine whether to use the elastic or the plastic formulation. The elastic ?trial? stress is compared with the yield stress from the past timestep. In my current setup, I do not compare the elastic ?trial? stress with the past yield stress but the current stress (including plastic correction) with the current yield stress. I think this is what leads to my problem. When I cheat and just tell petsc to use the plastic formulation from the time on where I expect plastic behaviour, I get convergence and the results look reasonable. So I tried to implement a flow condition which would not change during the nonlinear solver iteration steps. If the first, elastic predictor step results in yielding then, in my understanding, from there on we should expect plastic behaviour and not jump ?back and forth? between plastic and elastic behaviour. I have taken a look at pylith and it seems to use an explicit formulation for dynamic plasticity. I try to use an implicit formulation solving for displacement, stress, plastic strain and the plastic consistency operator at once. I am not aware of a possibility within the petsc framework to have an internal solver to compute stress state and internal variables depending on the displacement rate and then return to the outer iteration to solve for the correct displacements. This is how I found it done in literature. Is there a possibility to have such an ?internal? snes? Thanks, Max > > Thanks, > > Matt > > Thanks, > Max > >> >> Thanks, >> >> Matt >> >> Thanks, >> Max >> >> >> >> -- >> What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. >> -- Norbert Wiener >> >> http://www.caam.rice.edu/~mk51/ > > > > -- > What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. > -- Norbert Wiener > > http://www.caam.rice.edu/~mk51/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From C.Klaij at marin.nl Tue Aug 22 08:49:01 2017 From: C.Klaij at marin.nl (Klaij, Christiaan) Date: Tue, 22 Aug 2017 13:49:01 +0000 Subject: [petsc-users] Petsc ILU PC Change between 3.6.4 and 3.7.x? In-Reply-To: References: Message-ID: <1503409741903.19202@marin.nl> We also faced this problem in our code. So I've added: CALL PetscOptionsSetValue(PETSC_NULL_OBJECT,"-sub_pc_factor_shift_type","nonzero",ierr) since there seems to be no setter function for this (correct me if I'm wrong). Then everythings fine again. Out of curiosity, what was the reason to change the default behaviour? It seems to have really reduced the robustness of PCBJACOBI. > Message: 2 > Date: Fri, 11 Aug 2017 12:28:43 -0500 > From: Barry Smith > To: Gaetan Kenway > Cc: petsc-users > Subject: Re: [petsc-users] Petsc ILU PC Change between 3.6.4 and > 3.7.x? > Message-ID: > Content-Type: text/plain; charset="us-ascii" > > > Run with the additional option > > -sub_pc_factor_shift_type nonzero > > does this resolve the problem. We changed the default behavior for ILU when it detects "zero" pivots. > > Please let us know if this resolves the problem and we'll update the changes file. > > Barry dr. ir. Christiaan Klaij | Senior Researcher | Research & Development MARIN | T +31 317 49 33 44 | mailto:C.Klaij at marin.nl | http://www.marin.nl MARIN news: http://www.marin.nl/web/News/News-items/Improved-modelling-of-sheet-cavitation-dynamics-on-Delft-Twistll-Hydrofoil-1.htm From lawrence.mitchell at imperial.ac.uk Tue Aug 22 09:17:58 2017 From: lawrence.mitchell at imperial.ac.uk (Lawrence Mitchell) Date: Tue, 22 Aug 2017 15:17:58 +0100 Subject: [petsc-users] Petsc ILU PC Change between 3.6.4 and 3.7.x? In-Reply-To: <1503409741903.19202@marin.nl> References: <1503409741903.19202@marin.nl> Message-ID: <14d4c158-95b1-96ab-90b7-b81d3239b0dc@imperial.ac.uk> On 22/08/17 14:49, Klaij, Christiaan wrote: > CALL PetscOptionsSetValue(PETSC_NULL_OBJECT,"-sub_pc_factor_shift_type","nonzero",ierr) > > since there seems to be no setter function for this (correct me > if I'm wrong). I think you want PCFactorSetShiftType. Lawrence From bsmith at mcs.anl.gov Tue Aug 22 11:25:41 2017 From: bsmith at mcs.anl.gov (Barry Smith) Date: Tue, 22 Aug 2017 09:25:41 -0700 Subject: [petsc-users] Petsc ILU PC Change between 3.6.4 and 3.7.x? In-Reply-To: <1503409741903.19202@marin.nl> References: <1503409741903.19202@marin.nl> Message-ID: <6EABE1D7-CCD2-4D1F-8DD4-D1092F0D85DE@mcs.anl.gov> > On Aug 22, 2017, at 6:49 AM, Klaij, Christiaan wrote: > > We also faced this problem in our code. So I've added: > > CALL PetscOptionsSetValue(PETSC_NULL_OBJECT,"-sub_pc_factor_shift_type","nonzero",ierr) > > since there seems to be no setter function for this (correct me > if I'm wrong). Then everythings fine again. > > Out of curiosity, what was the reason to change the default > behaviour? The reason we changed this is that we would rather have a failure that makes the user aware of a serious problem then to produce "garbage" results. In some rare cases the shift can cause a huge jump in the preconditioned residual which then decreases rapidly while the true residual does not improve. This results in the KSP thinking it has converged while in fact it has essentially garbage for an answer. Under the previous model, where we shifted by default, users would in this rare case think they had reasonable solutions when they did not. For many users, such as yourself, the previous default behavior was fine because you didn't have the "rare case" but we decided it was best to protect against the rare case even though it would require other users such as yourself to add the option. Barry > It seems to have really reduced the robustness of > PCBJACOBI. > >> Message: 2 >> Date: Fri, 11 Aug 2017 12:28:43 -0500 >> From: Barry Smith >> To: Gaetan Kenway >> Cc: petsc-users >> Subject: Re: [petsc-users] Petsc ILU PC Change between 3.6.4 and >> 3.7.x? >> Message-ID: >> Content-Type: text/plain; charset="us-ascii" >> >> >> Run with the additional option >> >> -sub_pc_factor_shift_type nonzero >> >> does this resolve the problem. We changed the default behavior for ILU when it detects "zero" pivots. >> >> Please let us know if this resolves the problem and we'll update the changes file. >> >> Barry > > > dr. ir. Christiaan Klaij | Senior Researcher | Research & Development > MARIN | T +31 317 49 33 44 | mailto:C.Klaij at marin.nl | http://www.marin.nl > > MARIN news: http://www.marin.nl/web/News/News-items/Improved-modelling-of-sheet-cavitation-dynamics-on-Delft-Twistll-Hydrofoil-1.htm > From bcyee at umich.edu Tue Aug 22 16:04:49 2017 From: bcyee at umich.edu (Ben Yee) Date: Tue, 22 Aug 2017 17:04:49 -0400 Subject: [petsc-users] Which type of matrix do I use to define my own interpolation operators in PCMG? In-Reply-To: <87k21wd1jb.fsf@jedbrown.org> References: <87k21wd1jb.fsf@jedbrown.org> Message-ID: Thank you for the reply. If I understand the example correctly, you are suggesting that I define my interpolation matrix implicitly by defining the MATOP_MULT and MATOP_MULT_TRANSPOSE_ADD operations. In my case, I want the coarse grid operators defined via the Galerkin process, so would I also have to define the MATOP_PTAP operation? Also, is there a more convenient PETSc matrix type that I can use? My interpolation operators can easily be represented in matrix form, and it seems a bit unusual to have to define the matrix operations MATOP_MULT, MATOP_MULT_TRANSPOSE_ADD, and MATOP_PTAP myself. (Perhaps you are suggesting that defining these operations without explicitly constructing the matrix is more computationally efficient?) On Mon, Aug 21, 2017 at 6:00 PM, Jed Brown wrote: > Ben Yee writes: > > > Hi, > > > > I was wondering what type of matrix I should use if I want to define my > own > > interpolation matrix in PCMG. > > > > I don't have any DM objects, and I wanted to provide the matrix entries > to > > the interpolation matrix manually. Moreover, I want the coarse grid > > operators to be defined via the Galerkin process, so I only need to > define > > the interpolation operator. The fine grid problem/operator is defined > as a > > parallel sparse matrix using MATMPIAIJ. My interpolation operator is > also > > parallel and sparse -- does that mean I should also use MATMPIAIJ for my > > interpolation operator? > > > > I did some digging but I couldn't find any examples where the > > interpolation/restriction operators in PETSc were defined explicitly by > the > > user. > > src/ksp/pc/examples/tests/ex5.c > > > I also found the documentation for the matrix type MATMAIJ ( > > http://www.mcs.anl.gov/petsc/petsc-current/docs/ > > manualpages/Mat/MATMAIJ.html#MATMAIJ), which indicates that it is a > > specialized matrix for interpolation/restriction operations. However, > > I also noticed that the description for MATMAIJ indicates that it will > > interpolate each component the same way independently. I do have a > > multicomponent problem, but I was hoping to interpolate each component > > differently -- does that mean I can't use the MATMAIJ matrix type? > > Correct, MAIJ applies the Kronecker product of a scalar interpolation > with the identity so it acts the same on each component. It's more > efficient if you want each component treated the same way. > > > If it is recommended that I use the MATMAIJ matrix type, I would like > some > > clarification regarding the MatCreateMAIJ function. In particular, I'm > not > > really sure how the input matrix "A" (first argument of MatCreateMAIJ) is > > supposed to be -- the description of MatCreateMAIJ says "the AIJ matrix > > describing the action on blocks," but I don't know what that means. The > > use of MatCreateMAIJ in ex48.c is not really clear to me. > > > > Any guidance would be much appreciated. Thanks! > > > > -- > > Ben Yee > > > > NERS PhD Candidate, University of Michigan > > B.S. Mech. & Nuclear Eng., U.C. Berkeley > -- Ben Yee NERS PhD Candidate, University of Michigan B.S. Mech. & Nuclear Eng., U.C. Berkeley -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Tue Aug 22 17:07:09 2017 From: bsmith at mcs.anl.gov (Barry Smith) Date: Tue, 22 Aug 2017 15:07:09 -0700 Subject: [petsc-users] Which type of matrix do I use to define my own interpolation operators in PCMG? In-Reply-To: References: <87k21wd1jb.fsf@jedbrown.org> Message-ID: <32971245-158B-4B46-A522-C3E1C9DD1B26@mcs.anl.gov> You definitely want to use MPIAIJ. You don't want to use MPIMAIJ because it isn't as general as you need. Barry > On Aug 22, 2017, at 2:04 PM, Ben Yee wrote: > > Thank you for the reply. > > If I understand the example correctly, you are suggesting that I define my interpolation matrix implicitly by defining the MATOP_MULT and > MATOP_MULT_TRANSPOSE_ADD operations. In my case, I want the coarse grid operators defined via the Galerkin process, so would I also have to define the MATOP_PTAP operation? > > Also, is there a more convenient PETSc matrix type that I can use? My interpolation operators can easily be represented in matrix form, and it seems a bit unusual to have to define the matrix operations > MATOP_MULT, MATOP_MULT_TRANSPOSE_ADD, and MATOP_PTAP myself. (Perhaps you are suggesting that defining these operations without explicitly constructing the matrix is more computationally efficient?) > > On Mon, Aug 21, 2017 at 6:00 PM, Jed Brown wrote: > Ben Yee writes: > > > Hi, > > > > I was wondering what type of matrix I should use if I want to define my own > > interpolation matrix in PCMG. > > > > I don't have any DM objects, and I wanted to provide the matrix entries to > > the interpolation matrix manually. Moreover, I want the coarse grid > > operators to be defined via the Galerkin process, so I only need to define > > the interpolation operator. The fine grid problem/operator is defined as a > > parallel sparse matrix using MATMPIAIJ. My interpolation operator is also > > parallel and sparse -- does that mean I should also use MATMPIAIJ for my > > interpolation operator? > > > > I did some digging but I couldn't find any examples where the > > interpolation/restriction operators in PETSc were defined explicitly by the > > user. > > src/ksp/pc/examples/tests/ex5.c > > > I also found the documentation for the matrix type MATMAIJ ( > > http://www.mcs.anl.gov/petsc/petsc-current/docs/ > > manualpages/Mat/MATMAIJ.html#MATMAIJ), which indicates that it is a > > specialized matrix for interpolation/restriction operations. However, > > I also noticed that the description for MATMAIJ indicates that it will > > interpolate each component the same way independently. I do have a > > multicomponent problem, but I was hoping to interpolate each component > > differently -- does that mean I can't use the MATMAIJ matrix type? > > Correct, MAIJ applies the Kronecker product of a scalar interpolation > with the identity so it acts the same on each component. It's more > efficient if you want each component treated the same way. > > > If it is recommended that I use the MATMAIJ matrix type, I would like some > > clarification regarding the MatCreateMAIJ function. In particular, I'm not > > really sure how the input matrix "A" (first argument of MatCreateMAIJ) is > > supposed to be -- the description of MatCreateMAIJ says "the AIJ matrix > > describing the action on blocks," but I don't know what that means. The > > use of MatCreateMAIJ in ex48.c is not really clear to me. > > > > Any guidance would be much appreciated. Thanks! > > > > -- > > Ben Yee > > > > NERS PhD Candidate, University of Michigan > > B.S. Mech. & Nuclear Eng., U.C. Berkeley > > > > -- > Ben Yee > > NERS PhD Candidate, University of Michigan > B.S. Mech. & Nuclear Eng., U.C. Berkeley From C.Klaij at marin.nl Wed Aug 23 01:27:17 2017 From: C.Klaij at marin.nl (Klaij, Christiaan) Date: Wed, 23 Aug 2017 06:27:17 +0000 Subject: [petsc-users] Petsc ILU PC Change between 3.6.4 and 3.7.x? In-Reply-To: <6EABE1D7-CCD2-4D1F-8DD4-D1092F0D85DE@mcs.anl.gov> References: <1503409741903.19202@marin.nl>, <6EABE1D7-CCD2-4D1F-8DD4-D1092F0D85DE@mcs.anl.gov> Message-ID: <1503469637346.49904@marin.nl> Barry, Thanks for the explanation. We do have some rare cases that give false convergence, but decided to use CALL KSPSetNormType(ksp,KSP_NORM_UNPRECONDITIONED,ierr) so that convergence is always based on the true residual. Our results are much more consistent now. So that could have been your protection against the rare case as well, right? Why do you prefer left preconditioning? Chris dr. ir. Christiaan Klaij | Senior Researcher | Research & Development MARIN | T +31 317 49 33 44 | mailto:C.Klaij at marin.nl | http://www.marin.nl MARIN news: http://www.marin.nl/web/News/News-items/BlueWeek-October-911-Rostock.htm ________________________________________ From: Barry Smith Sent: Tuesday, August 22, 2017 6:25 PM To: Klaij, Christiaan Cc: petsc-users at mcs.anl.gov Subject: Re: [petsc-users] Petsc ILU PC Change between 3.6.4 and 3.7.x? > On Aug 22, 2017, at 6:49 AM, Klaij, Christiaan wrote: > > We also faced this problem in our code. So I've added: > > CALL PetscOptionsSetValue(PETSC_NULL_OBJECT,"-sub_pc_factor_shift_type","nonzero",ierr) > > since there seems to be no setter function for this (correct me > if I'm wrong). Then everythings fine again. > > Out of curiosity, what was the reason to change the default > behaviour? The reason we changed this is that we would rather have a failure that makes the user aware of a serious problem then to produce "garbage" results. In some rare cases the shift can cause a huge jump in the preconditioned residual which then decreases rapidly while the true residual does not improve. This results in the KSP thinking it has converged while in fact it has essentially garbage for an answer. Under the previous model, where we shifted by default, users would in this rare case think they had reasonable solutions when they did not. For many users, such as yourself, the previous default behavior was fine because you didn't have the "rare case" but we decided it was best to protect against the rare case even though it would require other users such as yourself to add the option. Barry From bsmith at mcs.anl.gov Wed Aug 23 01:30:29 2017 From: bsmith at mcs.anl.gov (Barry Smith) Date: Tue, 22 Aug 2017 23:30:29 -0700 Subject: [petsc-users] Petsc ILU PC Change between 3.6.4 and 3.7.x? In-Reply-To: <1503469637346.49904@marin.nl> References: <1503409741903.19202@marin.nl> <6EABE1D7-CCD2-4D1F-8DD4-D1092F0D85DE@mcs.anl.gov> <1503469637346.49904@marin.nl> Message-ID: Some argue that the preconditioned residual is "closer to" the norm of the error than the unpreconditioned norm. I don't have a solid mathematical reason to prefer left preconditioning with the preconditioned norm. Barry > On Aug 22, 2017, at 11:27 PM, Klaij, Christiaan wrote: > > Barry, > > Thanks for the explanation. > > We do have some rare cases that give false convergence, but > decided to use > > CALL KSPSetNormType(ksp,KSP_NORM_UNPRECONDITIONED,ierr) > > so that convergence is always based on the true residual. Our > results are much more consistent now. So that could have been > your protection against the rare case as well, right? Why do you > prefer left preconditioning? > > Chris > > > > dr. ir. Christiaan Klaij | Senior Researcher | Research & Development > MARIN | T +31 317 49 33 44 | mailto:C.Klaij at marin.nl | http://www.marin.nl > > MARIN news: http://www.marin.nl/web/News/News-items/BlueWeek-October-911-Rostock.htm > > ________________________________________ > From: Barry Smith > Sent: Tuesday, August 22, 2017 6:25 PM > To: Klaij, Christiaan > Cc: petsc-users at mcs.anl.gov > Subject: Re: [petsc-users] Petsc ILU PC Change between 3.6.4 and 3.7.x? > >> On Aug 22, 2017, at 6:49 AM, Klaij, Christiaan wrote: >> >> We also faced this problem in our code. So I've added: >> >> CALL PetscOptionsSetValue(PETSC_NULL_OBJECT,"-sub_pc_factor_shift_type","nonzero",ierr) >> >> since there seems to be no setter function for this (correct me >> if I'm wrong). Then everythings fine again. >> >> Out of curiosity, what was the reason to change the default >> behaviour? > > The reason we changed this is that we would rather have a failure that makes the user aware of a serious problem then to produce "garbage" results. In some rare cases the shift can cause a huge jump in the preconditioned residual which then decreases rapidly while the true residual does not improve. This results in the KSP thinking it has converged while in fact it has essentially garbage for an answer. Under the previous model, where we shifted by default, users would in this rare case think they had reasonable solutions when they did not. > > For many users, such as yourself, the previous default behavior was fine because you didn't have the "rare case" but we decided it was best to protect against the rare case even though it would require other users such as yourself to add the option. > > Barry From knepley at gmail.com Wed Aug 23 01:37:07 2017 From: knepley at gmail.com (Matthew Knepley) Date: Wed, 23 Aug 2017 02:37:07 -0400 Subject: [petsc-users] Petsc ILU PC Change between 3.6.4 and 3.7.x? In-Reply-To: References: <1503409741903.19202@marin.nl> <6EABE1D7-CCD2-4D1F-8DD4-D1092F0D85DE@mcs.anl.gov> <1503469637346.49904@marin.nl> Message-ID: On Wed, Aug 23, 2017 at 2:30 AM, Barry Smith wrote: > > Some argue that the preconditioned residual is "closer to" the norm of > the error than the unpreconditioned norm. I don't have a solid mathematical > reason to prefer left preconditioning with the preconditioned norm. Because you have || x - x_exact || < k(A) || r || where r is the residual and k is the condition number of A. If instead of A you use P A, which we assume has a lower condition number, then this bound is improved. Thanks, Matt > > Barry > > > > > On Aug 22, 2017, at 11:27 PM, Klaij, Christiaan > wrote: > > > > Barry, > > > > Thanks for the explanation. > > > > We do have some rare cases that give false convergence, but > > decided to use > > > > CALL KSPSetNormType(ksp,KSP_NORM_UNPRECONDITIONED,ierr) > > > > so that convergence is always based on the true residual. Our > > results are much more consistent now. So that could have been > > your protection against the rare case as well, right? Why do you > > prefer left preconditioning? > > > > Chris > > > > > > > > dr. ir. Christiaan Klaij | Senior Researcher | Research & Development > > MARIN | T +31 317 49 33 44 | mailto:C.Klaij at marin.nl | > http://www.marin.nl > > > > MARIN news: http://www.marin.nl/web/News/News-items/BlueWeek-October- > 911-Rostock.htm > > > > ________________________________________ > > From: Barry Smith > > Sent: Tuesday, August 22, 2017 6:25 PM > > To: Klaij, Christiaan > > Cc: petsc-users at mcs.anl.gov > > Subject: Re: [petsc-users] Petsc ILU PC Change between 3.6.4 and 3.7.x? > > > >> On Aug 22, 2017, at 6:49 AM, Klaij, Christiaan > wrote: > >> > >> We also faced this problem in our code. So I've added: > >> > >> CALL PetscOptionsSetValue(PETSC_NULL_OBJECT,"-sub_pc_factor_ > shift_type","nonzero",ierr) > >> > >> since there seems to be no setter function for this (correct me > >> if I'm wrong). Then everythings fine again. > >> > >> Out of curiosity, what was the reason to change the default > >> behaviour? > > > > The reason we changed this is that we would rather have a failure that > makes the user aware of a serious problem then to produce "garbage" > results. In some rare cases the shift can cause a huge jump in the > preconditioned residual which then decreases rapidly while the true > residual does not improve. This results in the KSP thinking it has > converged while in fact it has essentially garbage for an answer. Under the > previous model, where we shifted by default, users would in this rare case > think they had reasonable solutions when they did not. > > > > For many users, such as yourself, the previous default behavior was > fine because you didn't have the "rare case" but we decided it was best to > protect against the rare case even though it would require other users such > as yourself to add the option. > > > > Barry > > -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener http://www.caam.rice.edu/~mk51/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From C.Klaij at marin.nl Wed Aug 23 01:51:31 2017 From: C.Klaij at marin.nl (Klaij, Christiaan) Date: Wed, 23 Aug 2017 06:51:31 +0000 Subject: [petsc-users] Petsc ILU PC Change between 3.6.4 and 3.7.x? In-Reply-To: References: Message-ID: <1503471091705.26285@marin.nl> Lawrence, Well, I was looking for something like SubPCFactorSetShiftType, or is it supposed to somehow "trickle down" to the sub pc's? Or should I setup the pc, get the sub-pc's and then apply PCFactorSetShiftType on the sub pc's, something like CALL KSPSetup(ksp) CALL PCBJacobiGetSubKSP(ksp, subksp) CALL KSPGetPC(subksp, subpc, ierr) CALL PCFactorSetShiftType(subpc,MAT_SHIFT_NONZERO,ierr) Chris > Message: 2 > Date: Tue, 22 Aug 2017 15:17:58 +0100 > From: Lawrence Mitchell > To: petsc-users at mcs.anl.gov > Subject: Re: [petsc-users] Petsc ILU PC Change between 3.6.4 and > 3.7.x? > Message-ID: <14d4c158-95b1-96ab-90b7-b81d3239b0dc at imperial.ac.uk> > Content-Type: text/plain; charset=utf-8 > > > > On 22/08/17 14:49, Klaij, Christiaan wrote: > > CALL PetscOptionsSetValue(PETSC_NULL_OBJECT,"-sub_pc_factor_shift_type","nonzero",ierr) > > > > since there seems to be no setter function for this (correct me > > if I'm wrong). > > I think you want PCFactorSetShiftType. > > Lawrence dr. ir. Christiaan Klaij | Senior Researcher | Research & Development MARIN | T +31 317 49 33 44 | mailto:C.Klaij at marin.nl | http://www.marin.nl MARIN news: http://www.marin.nl/web/News/News-items/AMT17-October-1113-Glasgow.htm From lawrence.mitchell at imperial.ac.uk Wed Aug 23 04:18:43 2017 From: lawrence.mitchell at imperial.ac.uk (Lawrence Mitchell) Date: Wed, 23 Aug 2017 10:18:43 +0100 Subject: [petsc-users] Petsc ILU PC Change between 3.6.4 and 3.7.x? In-Reply-To: <1503471091705.26285@marin.nl> References: <1503471091705.26285@marin.nl> Message-ID: <5890ddce-2c5e-1ed2-3dac-24cb1d690749@imperial.ac.uk> On 23/08/17 07:51, Klaij, Christiaan wrote: > Lawrence, > > Well, I was looking for something like SubPCFactorSetShiftType, > or is it supposed to somehow "trickle down" to the sub pc's? Ah, I see. No, the approach below is what you need. Imagine that you used a sub_pc inside a multigrid smoother, you'd then need an MGLevelsSubPCFactorSetShiftType, which swiftly leads down the path of madness. > Or should I setup the pc, get the sub-pc's and then apply > PCFactorSetShiftType on the sub pc's, something like > > CALL KSPSetup(ksp) > CALL PCBJacobiGetSubKSP(ksp, subksp) > CALL KSPGetPC(subksp, subpc, ierr) > CALL PCFactorSetShiftType(subpc,MAT_SHIFT_NONZERO,ierr) Cheers, Lawrence From khaipham at mit.edu Wed Aug 23 05:42:09 2017 From: khaipham at mit.edu (Khai Pham) Date: Wed, 23 Aug 2017 10:42:09 +0000 Subject: [petsc-users] Petsc with OpenMP Message-ID: <69F29A8D72136041A5F665D423C3551474A1AD25@OC11EXPO29.exchange.mit.edu> Hi All, I searched for the information about Petsc with OpenMP support. I came cross Danyang Su question a couple of month ago at https://lists.mcs.anl.gov/pipermail/petsc-users/2017-June/032975.htmlhttps://lists.mcs.anl.gov/pipermail/petsc-users/2017-June/032975.html . I tried to configure Petsc version 3.5.4 but it said that "Please use petsc master (git branch) for OpenMP functionality". As Barry mentioned, one has to use an older version of petsc for OpenMp support. Could you please tell me what the the last version of petsc which supports OpenMP? Thanks! Best, Khai -------------- next part -------------- An HTML attachment was scrubbed... URL: From knepley at gmail.com Wed Aug 23 05:45:22 2017 From: knepley at gmail.com (Matthew Knepley) Date: Wed, 23 Aug 2017 06:45:22 -0400 Subject: [petsc-users] Petsc with OpenMP In-Reply-To: <69F29A8D72136041A5F665D423C3551474A1AD25@OC11EXPO29.exchange.mit.edu> References: <69F29A8D72136041A5F665D423C3551474A1AD25@OC11EXPO29.exchange.mit.edu> Message-ID: On Wed, Aug 23, 2017 at 6:42 AM, Khai Pham wrote: > Hi All, > > I searched for the information about Petsc with OpenMP support. I came > cross Danyang Su question a couple of month ago at > https://lists.mcs.anl.gov/pipermail/petsc-users/2017-June/032975.html > https://lists.mcs.anl.gov/pipermail/petsc-users/2017-June/032975.html . I > tried to configure Petsc version 3.5.4 but it said that "Please use petsc > master (git branch) for OpenMP functionality". As Barry mentioned, one has > to use an older version of petsc for OpenMp support. Could you please tell > me what the the last version of petsc which supports OpenMP? Thanks! > 1) It is 3.5.4. You might have to take out that check in configure. 2) The reason this was abandoned is that it is worse than useless. You do not get any speed improvement over using pure MPI, and it makes the whole code much more complicated. Thanks, Matt > Best, > Khai > -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener http://www.caam.rice.edu/~mk51/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From danyang.su at gmail.com Wed Aug 23 11:52:53 2017 From: danyang.su at gmail.com (Danyang Su) Date: Wed, 23 Aug 2017 09:52:53 -0700 Subject: [petsc-users] Petsc with OpenMP In-Reply-To: <69F29A8D72136041A5F665D423C3551474A1AD25@OC11EXPO29.exchange.mit.edu> References: <69F29A8D72136041A5F665D423C3551474A1AD25@OC11EXPO29.exchange.mit.edu> Message-ID: <415b82b1-57e2-d958-1274-7a4d177636de@gmail.com> Hi Khai, I finally implemented LIS solver (linear algebra library, http://www.ssisc.org/lis/index.en.html) to support the OpenMP and hybrid MPI-OpenMP since the old PETSc version with OpenMP is not officially supported any more. LIS is pretty easy to be implemented if you have already implemented PETSc. You can still use PETSc DMDA to do domain decomposition but just replace the linear solver for the hybrid version. Regards, Danyang On 17-08-23 03:42 AM, Khai Pham wrote: > Hi All, > > I searched for the information about Petsc with OpenMP support. I came > cross Danyang Su question a couple of month ago > at https://lists.mcs.anl.gov/pipermail/petsc-users/2017-June/032975.htmlhttps://lists.mcs.anl.gov/pipermail/petsc-users/2017-June/032975.html . > I tried to configure Petsc version 3.5.4 but it said that "Please use > petsc master (git branch) for OpenMP functionality". As Barry > mentioned, one has to use an older version of petsc for OpenMp > support. Could you please tell me what the the last version of petsc > which supports OpenMP? Thanks! > > Best, > Khai -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Wed Aug 23 12:06:30 2017 From: bsmith at mcs.anl.gov (Barry Smith) Date: Wed, 23 Aug 2017 10:06:30 -0700 Subject: [petsc-users] Petsc ILU PC Change between 3.6.4 and 3.7.x? In-Reply-To: <1503471091705.26285@marin.nl> References: <1503471091705.26285@marin.nl> Message-ID: In complicated scenarios with deep nesting of solvers it is sometimes not possible to set the options for the deeply nested solvers directly from the code with function calls. Thus we recommend using the options database for such cases. Note that one can provide options on the command line, in a file, with calls to PetscOptionsSetValue(), PetscOptionsInsertString(), PetscOptionsInsertFile() > On Aug 22, 2017, at 11:51 PM, Klaij, Christiaan wrote: > > Lawrence, > > Well, I was looking for something like SubPCFactorSetShiftType, > or is it supposed to somehow "trickle down" to the sub pc's? > > Or should I setup the pc, get the sub-pc's and then apply > PCFactorSetShiftType on the sub pc's, something like > > CALL KSPSetup(ksp) > CALL PCBJacobiGetSubKSP(ksp, subksp) > CALL KSPGetPC(subksp, subpc, ierr) > CALL PCFactorSetShiftType(subpc,MAT_SHIFT_NONZERO,ierr) > > Chris > >> Message: 2 >> Date: Tue, 22 Aug 2017 15:17:58 +0100 >> From: Lawrence Mitchell >> To: petsc-users at mcs.anl.gov >> Subject: Re: [petsc-users] Petsc ILU PC Change between 3.6.4 and >> 3.7.x? >> Message-ID: <14d4c158-95b1-96ab-90b7-b81d3239b0dc at imperial.ac.uk> >> Content-Type: text/plain; charset=utf-8 >> >> >> >> On 22/08/17 14:49, Klaij, Christiaan wrote: >>> CALL PetscOptionsSetValue(PETSC_NULL_OBJECT,"-sub_pc_factor_shift_type","nonzero",ierr) >>> >>> since there seems to be no setter function for this (correct me >>> if I'm wrong). >> >> I think you want PCFactorSetShiftType. >> >> Lawrence > > > dr. ir. Christiaan Klaij | Senior Researcher | Research & Development > MARIN | T +31 317 49 33 44 | mailto:C.Klaij at marin.nl | http://www.marin.nl > > MARIN news: http://www.marin.nl/web/News/News-items/AMT17-October-1113-Glasgow.htm > From C.Klaij at marin.nl Thu Aug 24 01:29:36 2017 From: C.Klaij at marin.nl (Klaij, Christiaan) Date: Thu, 24 Aug 2017 06:29:36 +0000 Subject: [petsc-users] Petsc ILU PC Change between 3.6.4 and 3.7.x? In-Reply-To: References: <1503409741903.19202@marin.nl> <6EABE1D7-CCD2-4D1F-8DD4-D1092F0D85DE@mcs.anl.gov> <1503469637346.49904@marin.nl> , Message-ID: <1503556176418.81994@marin.nl> Matt, Thanks, I can understand the lower condition number of P A, but what about r? Doesn't that change to P r and if so why can we assume that ||r|| and ||P r|| have the same order? Chris dr. ir. Christiaan Klaij | Senior Researcher | Research & Development MARIN | T +31 317 49 33 44 | C.Klaij at marin.nl | www.marin.nl [LinkedIn] [YouTube] [Twitter] [Facebook] MARIN news: New C-DRONE - for undisturbed wave spectrum measurements ________________________________ From: Matthew Knepley Sent: Wednesday, August 23, 2017 8:37 AM To: Barry Smith Cc: Klaij, Christiaan; petsc-users at mcs.anl.gov Subject: Re: [petsc-users] Petsc ILU PC Change between 3.6.4 and 3.7.x? On Wed, Aug 23, 2017 at 2:30 AM, Barry Smith > wrote: Some argue that the preconditioned residual is "closer to" the norm of the error than the unpreconditioned norm. I don't have a solid mathematical reason to prefer left preconditioning with the preconditioned norm. Because you have || x - x_exact || < k(A) || r || where r is the residual and k is the condition number of A. If instead of A you use P A, which we assume has a lower condition number, then this bound is improved. Thanks, Matt Barry > On Aug 22, 2017, at 11:27 PM, Klaij, Christiaan > wrote: > > Barry, > > Thanks for the explanation. > > We do have some rare cases that give false convergence, but > decided to use > > CALL KSPSetNormType(ksp,KSP_NORM_UNPRECONDITIONED,ierr) > > so that convergence is always based on the true residual. Our > results are much more consistent now. So that could have been > your protection against the rare case as well, right? Why do you > prefer left preconditioning? > > Chris > > > > dr. ir. Christiaan Klaij | Senior Researcher | Research & Development > MARIN | T +31 317 49 33 44 | mailto:C.Klaij at marin.nl | http://www.marin.nl > > MARIN news: http://www.marin.nl/web/News/News-items/BlueWeek-October-911-Rostock.htm > > ________________________________________ > From: Barry Smith > > Sent: Tuesday, August 22, 2017 6:25 PM > To: Klaij, Christiaan > Cc: petsc-users at mcs.anl.gov > Subject: Re: [petsc-users] Petsc ILU PC Change between 3.6.4 and 3.7.x? > >> On Aug 22, 2017, at 6:49 AM, Klaij, Christiaan > wrote: >> >> We also faced this problem in our code. So I've added: >> >> CALL PetscOptionsSetValue(PETSC_NULL_OBJECT,"-sub_pc_factor_shift_type","nonzero",ierr) >> >> since there seems to be no setter function for this (correct me >> if I'm wrong). Then everythings fine again. >> >> Out of curiosity, what was the reason to change the default >> behaviour? > > The reason we changed this is that we would rather have a failure that makes the user aware of a serious problem then to produce "garbage" results. In some rare cases the shift can cause a huge jump in the preconditioned residual which then decreases rapidly while the true residual does not improve. This results in the KSP thinking it has converged while in fact it has essentially garbage for an answer. Under the previous model, where we shifted by default, users would in this rare case think they had reasonable solutions when they did not. > > For many users, such as yourself, the previous default behavior was fine because you didn't have the "rare case" but we decided it was best to protect against the rare case even though it would require other users such as yourself to add the option. > > Barry -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener http://www.caam.rice.edu/~mk51/ -------------- next part -------------- An HTML attachment was scrubbed... URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: image9b01c8.PNG Type: image/png Size: 293 bytes Desc: image9b01c8.PNG URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: image897a3b.PNG Type: image/png Size: 331 bytes Desc: image897a3b.PNG URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: imagea59660.PNG Type: image/png Size: 333 bytes Desc: imagea59660.PNG URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: imageb99035.PNG Type: image/png Size: 253 bytes Desc: imageb99035.PNG URL: From knepley at gmail.com Thu Aug 24 02:34:56 2017 From: knepley at gmail.com (Matthew Knepley) Date: Thu, 24 Aug 2017 03:34:56 -0400 Subject: [petsc-users] Petsc ILU PC Change between 3.6.4 and 3.7.x? In-Reply-To: <1503556176418.81994@marin.nl> References: <1503409741903.19202@marin.nl> <6EABE1D7-CCD2-4D1F-8DD4-D1092F0D85DE@mcs.anl.gov> <1503469637346.49904@marin.nl> <1503556176418.81994@marin.nl> Message-ID: On Thu, Aug 24, 2017 at 2:29 AM, Klaij, Christiaan wrote: > Matt, > > Thanks, I can understand the lower condition number of P A, but > what about r? Doesn't that change to P r and if so why can we > assume that ||r|| and ||P r|| have the same order? > r and Pr are the things we can control. We make them whatever we want. Matt > Chris > > > dr. ir. Christiaan Klaij | Senior Researcher | Research & Development > MARIN | T +31 317 49 33 44 <+31%20317%20493%20344> | C.Klaij at marin.nl | > www.marin.nl > > [image: LinkedIn] [image: > YouTube] [image: Twitter] > [image: Facebook] > > MARIN news: New C-DRONE - for undisturbed wave spectrum measurements > > > ------------------------------ > *From:* Matthew Knepley > *Sent:* Wednesday, August 23, 2017 8:37 AM > *To:* Barry Smith > *Cc:* Klaij, Christiaan; petsc-users at mcs.anl.gov > *Subject:* Re: [petsc-users] Petsc ILU PC Change between 3.6.4 and 3.7.x? > > On Wed, Aug 23, 2017 at 2:30 AM, Barry Smith wrote: > >> >> Some argue that the preconditioned residual is "closer to" the norm of >> the error than the unpreconditioned norm. I don't have a solid mathematical >> reason to prefer left preconditioning with the preconditioned norm. > > > Because you have || x - x_exact || < k(A) || r || > > where r is the residual and k is the condition number of A. If instead of > A you use P A, which we assume has a lower condition number, then > this bound is improved. > > Thanks, > > Matt > > >> >> Barry >> >> >> >> > On Aug 22, 2017, at 11:27 PM, Klaij, Christiaan >> wrote: >> > >> > Barry, >> > >> > Thanks for the explanation. >> > >> > We do have some rare cases that give false convergence, but >> > decided to use >> > >> > CALL KSPSetNormType(ksp,KSP_NORM_UNPRECONDITIONED,ierr) >> > >> > so that convergence is always based on the true residual. Our >> > results are much more consistent now. So that could have been >> > your protection against the rare case as well, right? Why do you >> > prefer left preconditioning? >> > >> > Chris >> > >> > >> > >> > dr. ir. Christiaan Klaij | Senior Researcher | Research & Development >> > MARIN | T +31 317 49 33 44 | mailto:C.Klaij at marin.nl | >> http://www.marin.nl >> > >> > MARIN news: http://www.marin.nl/web/News/N >> ews-items/BlueWeek-October-911-Rostock.htm >> > >> > ________________________________________ >> > From: Barry Smith >> > Sent: Tuesday, August 22, 2017 6:25 PM >> > To: Klaij, Christiaan >> > Cc: petsc-users at mcs.anl.gov >> > Subject: Re: [petsc-users] Petsc ILU PC Change between 3.6.4 and 3.7.x? >> > >> >> On Aug 22, 2017, at 6:49 AM, Klaij, Christiaan >> wrote: >> >> >> >> We also faced this problem in our code. So I've added: >> >> >> >> CALL PetscOptionsSetValue(PETSC_NULL_OBJECT,"-sub_pc_factor_shift >> _type","nonzero",ierr) >> >> >> >> since there seems to be no setter function for this (correct me >> >> if I'm wrong). Then everythings fine again. >> >> >> >> Out of curiosity, what was the reason to change the default >> >> behaviour? >> > >> > The reason we changed this is that we would rather have a failure >> that makes the user aware of a serious problem then to produce "garbage" >> results. In some rare cases the shift can cause a huge jump in the >> preconditioned residual which then decreases rapidly while the true >> residual does not improve. This results in the KSP thinking it has >> converged while in fact it has essentially garbage for an answer. Under the >> previous model, where we shifted by default, users would in this rare case >> think they had reasonable solutions when they did not. >> > >> > For many users, such as yourself, the previous default behavior was >> fine because you didn't have the "rare case" but we decided it was best to >> protect against the rare case even though it would require other users such >> as yourself to add the option. >> > >> > Barry >> >> > > > -- > What most experimenters take for granted before they begin their > experiments is infinitely more interesting than any results to which their > experiments lead. > -- Norbert Wiener > > http://www.caam.rice.edu/~mk51/ > > -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener http://www.caam.rice.edu/~mk51/ -------------- next part -------------- An HTML attachment was scrubbed... URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: imagea59660.PNG Type: image/png Size: 333 bytes Desc: not available URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: image9b01c8.PNG Type: image/png Size: 293 bytes Desc: not available URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: image897a3b.PNG Type: image/png Size: 331 bytes Desc: not available URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: imageb99035.PNG Type: image/png Size: 253 bytes Desc: not available URL: From khaipham at mit.edu Thu Aug 24 04:12:03 2017 From: khaipham at mit.edu (Khai Pham) Date: Thu, 24 Aug 2017 09:12:03 +0000 Subject: [petsc-users] Petsc with OpenMP In-Reply-To: <415b82b1-57e2-d958-1274-7a4d177636de@gmail.com> References: <69F29A8D72136041A5F665D423C3551474A1AD25@OC11EXPO29.exchange.mit.edu>, <415b82b1-57e2-d958-1274-7a4d177636de@gmail.com> Message-ID: <69F29A8D72136041A5F665D423C3551474A1AD71@OC11EXPO29.exchange.mit.edu> Hi Danyang, Thank you for the information. Khai ________________________________ From: Danyang Su [danyang.su at gmail.com] Sent: Wednesday, August 23, 2017 12:52 PM To: Khai Pham; PETSc Subject: Re: [petsc-users] Petsc with OpenMP Hi Khai, I finally implemented LIS solver (linear algebra library, http://www.ssisc.org/lis/index.en.html) to support the OpenMP and hybrid MPI-OpenMP since the old PETSc version with OpenMP is not officially supported any more. LIS is pretty easy to be implemented if you have already implemented PETSc. You can still use PETSc DMDA to do domain decomposition but just replace the linear solver for the hybrid version. Regards, Danyang On 17-08-23 03:42 AM, Khai Pham wrote: Hi All, I searched for the information about Petsc with OpenMP support. I came cross Danyang Su question a couple of month ago at https://lists.mcs.anl.gov/pipermail/petsc-users/2017-June/032975.htmlhttps://lists.mcs.anl.gov/pipermail/petsc-users/2017-June/032975.html . I tried to configure Petsc version 3.5.4 but it said that "Please use petsc master (git branch) for OpenMP functionality". As Barry mentioned, one has to use an older version of petsc for OpenMp support. Could you please tell me what the the last version of petsc which supports OpenMP? Thanks! Best, Khai -------------- next part -------------- An HTML attachment was scrubbed... URL: From jed at jedbrown.org Thu Aug 24 11:01:55 2017 From: jed at jedbrown.org (Jed Brown) Date: Thu, 24 Aug 2017 10:01:55 -0600 Subject: [petsc-users] Petsc ILU PC Change between 3.6.4 and 3.7.x? In-Reply-To: <1503556176418.81994@marin.nl> References: <1503409741903.19202@marin.nl> <6EABE1D7-CCD2-4D1F-8DD4-D1092F0D85DE@mcs.anl.gov> <1503469637346.49904@marin.nl> <1503556176418.81994@marin.nl> Message-ID: <87lgm9kl8s.fsf@jedbrown.org> "Klaij, Christiaan" writes: > Matt, > > Thanks, I can understand the lower condition number of P A, but > what about r? Doesn't that change to P r and if so why can we > assume that ||r|| and ||P r|| have the same order? Matt's equation was of course wrong in a literal sense, but is based on the right moral convictions. We have r = A (x - x_exact) which implies that ||r|| <= ||A|| || x - x_exact ||. We also have x - x_exact = A^{-1} r so || x - x_exact || <= || A^{-1} || ||r||. Combining these gives the two-sided bound || A ||^{-1} ||r|| <= || x - x_exact || <= || A^{-1} || ||r||. The ratio of the high and low bounds is the condition number. Our convergence tolerance controls the norm of the residual (in a relative or absolute sense). If the condition number is smaller, we get tighter control on the error. If you are confident that your preconditioner reduces the condition number, it makes sense to measure convergence in the preconditioned norm (this is natural with left preconditioning for GMRES), in which the bounds above are in terms of the preconditioned operator. The main reason for PETSc to keep the preconditioned norm as a default is that many users, especially beginners, produce poorly scaled equations, e.g., with penalty boundary conditions or with disparate scales between fields with different units (displacement, pressure, velocity, energy, etc.). You will often see the unpreconditioned residual drop by 10 orders of magnitude on the first iteration because the penalty boundary conditions are satisfied despite the solution being completely wrong inside the domain. On the other hand, the preconditioned residual causes misdiagnosis of convergence if the preconditioner is (nearly) singular, as is the case with some preconditioners applied to saddle point problems, for example. But this is easy to identify using -ksp_monitor_true_residual. > > Chris > > > dr. ir. Christiaan Klaij | Senior Researcher | Research & Development > MARIN | T +31 317 49 33 44 | C.Klaij at marin.nl | www.marin.nl > > [LinkedIn] [YouTube] [Twitter] [Facebook] > MARIN news: New C-DRONE - for undisturbed wave spectrum measurements > > ________________________________ > From: Matthew Knepley > Sent: Wednesday, August 23, 2017 8:37 AM > To: Barry Smith > Cc: Klaij, Christiaan; petsc-users at mcs.anl.gov > Subject: Re: [petsc-users] Petsc ILU PC Change between 3.6.4 and 3.7.x? > > On Wed, Aug 23, 2017 at 2:30 AM, Barry Smith > wrote: > > Some argue that the preconditioned residual is "closer to" the norm of the error than the unpreconditioned norm. I don't have a solid mathematical reason to prefer left preconditioning with the preconditioned norm. > > Because you have || x - x_exact || < k(A) || r || > > where r is the residual and k is the condition number of A. If instead of A you use P A, which we assume has a lower condition number, then > this bound is improved. > > Thanks, > > Matt > > > Barry > > > >> On Aug 22, 2017, at 11:27 PM, Klaij, Christiaan > wrote: >> >> Barry, >> >> Thanks for the explanation. >> >> We do have some rare cases that give false convergence, but >> decided to use >> >> CALL KSPSetNormType(ksp,KSP_NORM_UNPRECONDITIONED,ierr) >> >> so that convergence is always based on the true residual. Our >> results are much more consistent now. So that could have been >> your protection against the rare case as well, right? Why do you >> prefer left preconditioning? >> >> Chris >> >> >> >> dr. ir. Christiaan Klaij | Senior Researcher | Research & Development >> MARIN | T +31 317 49 33 44 | mailto:C.Klaij at marin.nl | http://www.marin.nl >> >> MARIN news: http://www.marin.nl/web/News/News-items/BlueWeek-October-911-Rostock.htm >> >> ________________________________________ >> From: Barry Smith > >> Sent: Tuesday, August 22, 2017 6:25 PM >> To: Klaij, Christiaan >> Cc: petsc-users at mcs.anl.gov >> Subject: Re: [petsc-users] Petsc ILU PC Change between 3.6.4 and 3.7.x? >> >>> On Aug 22, 2017, at 6:49 AM, Klaij, Christiaan > wrote: >>> >>> We also faced this problem in our code. So I've added: >>> >>> CALL PetscOptionsSetValue(PETSC_NULL_OBJECT,"-sub_pc_factor_shift_type","nonzero",ierr) >>> >>> since there seems to be no setter function for this (correct me >>> if I'm wrong). Then everythings fine again. >>> >>> Out of curiosity, what was the reason to change the default >>> behaviour? >> >> The reason we changed this is that we would rather have a failure that makes the user aware of a serious problem then to produce "garbage" results. In some rare cases the shift can cause a huge jump in the preconditioned residual which then decreases rapidly while the true residual does not improve. This results in the KSP thinking it has converged while in fact it has essentially garbage for an answer. Under the previous model, where we shifted by default, users would in this rare case think they had reasonable solutions when they did not. >> >> For many users, such as yourself, the previous default behavior was fine because you didn't have the "rare case" but we decided it was best to protect against the rare case even though it would require other users such as yourself to add the option. >> >> Barry > > > > > -- > What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. > -- Norbert Wiener > > http://www.caam.rice.edu/~mk51/ -------------- next part -------------- A non-text attachment was scrubbed... Name: signature.asc Type: application/pgp-signature Size: 832 bytes Desc: not available URL: From epscodes at gmail.com Thu Aug 24 12:28:44 2017 From: epscodes at gmail.com (Xiangdong) Date: Thu, 24 Aug 2017 13:28:44 -0400 Subject: [petsc-users] MatMult performance on baij vs aij Message-ID: Hello everyone, For the same sparse matrix, will the storage format (baij or aij) have a noticeable performance effect on MatMult give the baij may have a better locality? Thank you. Best, Xiangdong -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Thu Aug 24 12:36:53 2017 From: bsmith at mcs.anl.gov (Barry Smith) Date: Thu, 24 Aug 2017 10:36:53 -0700 Subject: [petsc-users] MatMult performance on baij vs aij In-Reply-To: References: Message-ID: Depending on the block size and the particular hardware and compiler BAIJ can give a noticeable improvement. Expect something between 1 and 2 times faster. Barry > On Aug 24, 2017, at 10:28 AM, Xiangdong wrote: > > Hello everyone, > > For the same sparse matrix, will the storage format (baij or aij) have a noticeable performance effect on MatMult give the baij may have a better locality? > > Thank you. > > Best, > Xiangdong From rupp at iue.tuwien.ac.at Thu Aug 24 12:38:33 2017 From: rupp at iue.tuwien.ac.at (Karl Rupp) Date: Thu, 24 Aug 2017 12:38:33 -0500 Subject: [petsc-users] MatMult performance on baij vs aij In-Reply-To: References: Message-ID: <160f25a9-e13f-7e29-73d9-eb3666da8608@iue.tuwien.ac.at> Hi, > For the same sparse matrix, will the storage format (baij or aij) have a > noticeable performance effect on MatMult give the baij may have a > better locality? The gains are mostly due to the reduced number of indices loaded from memory. For normal aij, each floating point number (typically 8 bytes) requires an index (typically 4 bytes, unless you use 64 bit indices). With baij you only need one index per block. For example, if your block size is 3x3, only one index for 9 floating point numbers is needed. Thus, your performance gains are not going to be dramatic, but still... :-) Best regards, Karli From gregory.meyer at gmail.com Thu Aug 24 15:51:08 2017 From: gregory.meyer at gmail.com (Greg Meyer) Date: Thu, 24 Aug 2017 20:51:08 +0000 Subject: [petsc-users] Shell matrix MatCreateVecs Message-ID: Hi, I have written a shell matrix for non-standard vectors (CUDA to be specific) that works great. MatMult and MatNorm perform as they should. However, when I try to use it in a SLEPc algorithm, it breaks because MatCreateVecs yields standard vectors even if I set "-vec_type cuda". Looking through the source etc. it seems that MatShellSetOperation can't be used to implement a new MatCreateVecs function (MATOP_CREATEVECS does not exist). Is there a way to change the type of vector that comes from MatCreateVecs for shell matrices? Thanks in advance, Greg -------------- next part -------------- An HTML attachment was scrubbed... URL: From jroman at dsic.upv.es Thu Aug 24 16:28:04 2017 From: jroman at dsic.upv.es (Jose E. Roman) Date: Thu, 24 Aug 2017 23:28:04 +0200 Subject: [petsc-users] Shell matrix MatCreateVecs In-Reply-To: References: Message-ID: <765C4A93-2CFB-468A-998A-C90AC23EB428@dsic.upv.es> > El 24 ago 2017, a las 22:51, Greg Meyer escribi?: > > Hi, > > I have written a shell matrix for non-standard vectors (CUDA to be specific) that works great. MatMult and MatNorm perform as they should. However, when I try to use it in a SLEPc algorithm, it breaks because MatCreateVecs yields standard vectors even if I set "-vec_type cuda". Looking through the source etc. it seems that MatShellSetOperation can't be used to implement a new MatCreateVecs function (MATOP_CREATEVECS does not exist). Is there a way to change the type of vector that comes from MatCreateVecs for shell matrices? > > Thanks in advance, > Greg It is MATOP_GET_VECS. If you implement this operation, most SLEPc functionality should work with CUDA. PETSc developers: shouldn't MATOP_GET_VECS be renamed to MATOP_CREATE_VECS ? Jose From mirzadeh at gmail.com Thu Aug 24 20:42:38 2017 From: mirzadeh at gmail.com (Mohammad Mirzadeh) Date: Thu, 24 Aug 2017 21:42:38 -0400 Subject: [petsc-users] Logo? Message-ID: Hey folks, Does PETSc have any sort of official logo? I often like to include these in my acknowledgment slides but can't find any for PETSc. I'd appreciate if you could point me to if there is one. Mohammad -------------- next part -------------- An HTML attachment was scrubbed... URL: From jed at jedbrown.org Thu Aug 24 21:42:38 2017 From: jed at jedbrown.org (Jed Brown) Date: Thu, 24 Aug 2017 20:42:38 -0600 Subject: [petsc-users] Shell matrix MatCreateVecs In-Reply-To: <765C4A93-2CFB-468A-998A-C90AC23EB428@dsic.upv.es> References: <765C4A93-2CFB-468A-998A-C90AC23EB428@dsic.upv.es> Message-ID: <87efs0l65d.fsf@jedbrown.org> "Jose E. Roman" writes: >> El 24 ago 2017, a las 22:51, Greg Meyer escribi?: >> >> Hi, >> >> I have written a shell matrix for non-standard vectors (CUDA to be specific) that works great. MatMult and MatNorm perform as they should. However, when I try to use it in a SLEPc algorithm, it breaks because MatCreateVecs yields standard vectors even if I set "-vec_type cuda". Looking through the source etc. it seems that MatShellSetOperation can't be used to implement a new MatCreateVecs function (MATOP_CREATEVECS does not exist). Is there a way to change the type of vector that comes from MatCreateVecs for shell matrices? >> >> Thanks in advance, >> Greg > > It is MATOP_GET_VECS. If you implement this operation, most SLEPc functionality should work with CUDA. > > PETSc developers: shouldn't MATOP_GET_VECS be renamed to MATOP_CREATE_VECS ? Yes, in their eagerness to rename interfaces, people often forget to complete all parts of the job. The MATOP interface has shown itself to be high maintenance. -------------- next part -------------- A non-text attachment was scrubbed... Name: signature.asc Type: application/pgp-signature Size: 832 bytes Desc: not available URL: From bsmith at mcs.anl.gov Fri Aug 25 00:05:12 2017 From: bsmith at mcs.anl.gov (Barry Smith) Date: Thu, 24 Aug 2017 22:05:12 -0700 Subject: [petsc-users] Shell matrix MatCreateVecs In-Reply-To: <87efs0l65d.fsf@jedbrown.org> References: <765C4A93-2CFB-468A-998A-C90AC23EB428@dsic.upv.es> <87efs0l65d.fsf@jedbrown.org> Message-ID: <49EF7C1C-45D5-4F19-8254-33024A19C32B@mcs.anl.gov> > On Aug 24, 2017, at 7:42 PM, Jed Brown wrote: > > "Jose E. Roman" writes: > >>> El 24 ago 2017, a las 22:51, Greg Meyer escribi?: >>> >>> Hi, >>> >>> I have written a shell matrix for non-standard vectors (CUDA to be specific) that works great. MatMult and MatNorm perform as they should. However, when I try to use it in a SLEPc algorithm, it breaks because MatCreateVecs yields standard vectors even if I set "-vec_type cuda". Looking through the source etc. it seems that MatShellSetOperation can't be used to implement a new MatCreateVecs function (MATOP_CREATEVECS does not exist). Is there a way to change the type of vector that comes from MatCreateVecs for shell matrices? >>> >>> Thanks in advance, >>> Greg >> >> It is MATOP_GET_VECS. If you implement this operation, most SLEPc functionality should work with CUDA. >> >> PETSc developers: shouldn't MATOP_GET_VECS be renamed to MATOP_CREATE_VECS ? > > Yes, in their eagerness to rename interfaces, You mean, eagerness to improve PETSc > people often forget to > complete all parts of the job. The MATOP interface has shown itself to > be high maintenance. From dave.mayhem23 at gmail.com Fri Aug 25 03:42:25 2017 From: dave.mayhem23 at gmail.com (Dave May) Date: Fri, 25 Aug 2017 08:42:25 +0000 Subject: [petsc-users] Logo? In-Reply-To: References: Message-ID: On Fri, 25 Aug 2017 at 03:43, Mohammad Mirzadeh wrote: > Hey folks, > > Does PETSc have any sort of official logo? > The answer is no I often like to include these in my acknowledgment slides but can't find > any for PETSc. I'd appreciate if you could point me to if there is one. > I take a screen shot of the red text on the lovely cornflower blue backdrop from the website and use that as the logo. petsc was created before catchy logos where fashionable. :) (and seemingly developers devote time to coding and not artistic endeavors) Thanks, Dave > Mohammad > -------------- next part -------------- An HTML attachment was scrubbed... URL: From weyenst at gmail.com Fri Aug 25 05:01:36 2017 From: weyenst at gmail.com (Toon Weyens) Date: Fri, 25 Aug 2017 10:01:36 +0000 Subject: [petsc-users] Parallel dense solve with submatrices Message-ID: Dear all, For a Bounday Element Method problem I require the solution of a system of linear equations with multiple right-hand sides. Though this is a dense system, I still want to do it via Petsc. Would the best way to do this be through something such as -ksp_type preonly -pc_type lu -pc_factor_mat_solver_package mumps ? Furthermore, I refine my grid in a regular way, which leads to a new system of equations of size 2N x 2N where N is the original number of unknowns before refining it. The upper-left matrix A_11 in this new system is identical to the unrefined matrix (multiplied by 0.5). The other three blocks A_12, A_21 and A_22 are new: A_11 A_12 A_21 A_22 The question is now whether knowledge about the unrefined matrix A_11 can be used to speed up calculation of the refined system? I was thinking, for example, about using the LU decomposition of A_11 to calculate the LU decomposition of the entire matrix A using the well-known formula's L_21 U_11 = A_21 L_11 U_12 = A_12 L_22 U_22 = A_22 - L_21 U_12 where L_21 and U_12 are full matrices, L_11, L_22 are lower triangular matrices and U_11, U_22 are upper triangular. Is there any way to do this in Petsc? Or is there a better thing I can do? Thanks very much in advance! Regards. Dr. Toon Weyens ITER Organization -------------- next part -------------- An HTML attachment was scrubbed... URL: From balay at mcs.anl.gov Fri Aug 25 08:05:16 2017 From: balay at mcs.anl.gov (Satish Balay) Date: Fri, 25 Aug 2017 08:05:16 -0500 Subject: [petsc-users] Logo? In-Reply-To: References: Message-ID: Well we had this logo created many years ago - but I don't remember the last time we used it.. https://bitbucket.org/petsc/petsc/src/15785cf8cfc19332123bc897ee7bf170d1911f0c/src/docs/tex/pictures/petsc_color_logo.jpg?at=master&fileviewer=file-view-default Satish On Fri, 25 Aug 2017, Dave May wrote: > On Fri, 25 Aug 2017 at 03:43, Mohammad Mirzadeh wrote: > > > Hey folks, > > > > Does PETSc have any sort of official logo? > > > > The answer is no > > I often like to include these in my acknowledgment slides but can't find > > any for PETSc. I'd appreciate if you could point me to if there is one. > > > > I take a screen shot of the red text on the lovely cornflower blue backdrop > from the website and use that as the logo. > > petsc was created before catchy logos where fashionable. :) (and seemingly > developers devote time to coding and not artistic endeavors) > > > Thanks, > Dave > > > > Mohammad > > > From lukas.drinkt.thee at gmail.com Fri Aug 25 08:17:05 2017 From: lukas.drinkt.thee at gmail.com (Lukas van de Wiel) Date: Fri, 25 Aug 2017 15:17:05 +0200 Subject: [petsc-users] Logo? In-Reply-To: References: Message-ID: Well, I would rather not use a logo at all than use that design, to be honest... On Fri, Aug 25, 2017 at 3:05 PM, Satish Balay wrote: > Well we had this logo created many years ago - but I don't remember the > last time we used it.. > > https://bitbucket.org/petsc/petsc/src/15785cf8cfc19332123bc897ee7bf1 > 70d1911f0c/src/docs/tex/pictures/petsc_color_logo.jpg? > at=master&fileviewer=file-view-default > > Satish > > On Fri, 25 Aug 2017, Dave May wrote: > > > On Fri, 25 Aug 2017 at 03:43, Mohammad Mirzadeh > wrote: > > > > > Hey folks, > > > > > > Does PETSc have any sort of official logo? > > > > > > > The answer is no > > > > I often like to include these in my acknowledgment slides but can't find > > > any for PETSc. I'd appreciate if you could point me to if there is one. > > > > > > > I take a screen shot of the red text on the lovely cornflower blue > backdrop > > from the website and use that as the logo. > > > > petsc was created before catchy logos where fashionable. :) (and > seemingly > > developers devote time to coding and not artistic endeavors) > > > > > > Thanks, > > Dave > > > > > > > Mohammad > > > > > > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From jed at jedbrown.org Fri Aug 25 09:12:36 2017 From: jed at jedbrown.org (Jed Brown) Date: Fri, 25 Aug 2017 08:12:36 -0600 Subject: [petsc-users] Logo? In-Reply-To: References: Message-ID: <87bmn3lorv.fsf@jedbrown.org> Haha, there's a reason nobody uses it. ;-) Lukas van de Wiel writes: > Well, I would rather not use a logo at all than use that design, to be > honest... > > On Fri, Aug 25, 2017 at 3:05 PM, Satish Balay wrote: > >> Well we had this logo created many years ago - but I don't remember the >> last time we used it.. >> >> https://bitbucket.org/petsc/petsc/src/15785cf8cfc19332123bc897ee7bf1 >> 70d1911f0c/src/docs/tex/pictures/petsc_color_logo.jpg? >> at=master&fileviewer=file-view-default >> >> Satish >> >> On Fri, 25 Aug 2017, Dave May wrote: >> >> > On Fri, 25 Aug 2017 at 03:43, Mohammad Mirzadeh >> wrote: >> > >> > > Hey folks, >> > > >> > > Does PETSc have any sort of official logo? >> > > >> > >> > The answer is no >> > >> > I often like to include these in my acknowledgment slides but can't find >> > > any for PETSc. I'd appreciate if you could point me to if there is one. >> > > >> > >> > I take a screen shot of the red text on the lovely cornflower blue >> backdrop >> > from the website and use that as the logo. >> > >> > petsc was created before catchy logos where fashionable. :) (and >> seemingly >> > developers devote time to coding and not artistic endeavors) >> > >> > >> > Thanks, >> > Dave >> > >> > >> > > Mohammad >> > > >> > >> >> -------------- next part -------------- A non-text attachment was scrubbed... Name: signature.asc Type: application/pgp-signature Size: 832 bytes Desc: not available URL: From jed at jedbrown.org Fri Aug 25 09:19:48 2017 From: jed at jedbrown.org (Jed Brown) Date: Fri, 25 Aug 2017 08:19:48 -0600 Subject: [petsc-users] Shell matrix MatCreateVecs In-Reply-To: <49EF7C1C-45D5-4F19-8254-33024A19C32B@mcs.anl.gov> References: <765C4A93-2CFB-468A-998A-C90AC23EB428@dsic.upv.es> <87efs0l65d.fsf@jedbrown.org> <49EF7C1C-45D5-4F19-8254-33024A19C32B@mcs.anl.gov> Message-ID: <878ti7lofv.fsf@jedbrown.org> Barry Smith writes: >> On Aug 24, 2017, at 7:42 PM, Jed Brown wrote: >> >> "Jose E. Roman" writes: >> >>>> El 24 ago 2017, a las 22:51, Greg Meyer escribi?: >>>> >>>> Hi, >>>> >>>> I have written a shell matrix for non-standard vectors (CUDA to be specific) that works great. MatMult and MatNorm perform as they should. However, when I try to use it in a SLEPc algorithm, it breaks because MatCreateVecs yields standard vectors even if I set "-vec_type cuda". Looking through the source etc. it seems that MatShellSetOperation can't be used to implement a new MatCreateVecs function (MATOP_CREATEVECS does not exist). Is there a way to change the type of vector that comes from MatCreateVecs for shell matrices? >>>> >>>> Thanks in advance, >>>> Greg >>> >>> It is MATOP_GET_VECS. If you implement this operation, most SLEPc functionality should work with CUDA. >>> >>> PETSc developers: shouldn't MATOP_GET_VECS be renamed to MATOP_CREATE_VECS ? >> >> Yes, in their eagerness to rename interfaces, > > You mean, eagerness to improve PETSc Exactly. -------------- next part -------------- A non-text attachment was scrubbed... Name: signature.asc Type: application/pgp-signature Size: 832 bytes Desc: not available URL: From bsmith at mcs.anl.gov Fri Aug 25 12:28:47 2017 From: bsmith at mcs.anl.gov (Barry Smith) Date: Fri, 25 Aug 2017 10:28:47 -0700 Subject: [petsc-users] Logo? In-Reply-To: References: Message-ID: > On Aug 25, 2017, at 1:42 AM, Dave May wrote: > > > On Fri, 25 Aug 2017 at 03:43, Mohammad Mirzadeh wrote: > Hey folks, > > Does PETSc have any sort of official logo? > > The answer is no > > I often like to include these in my acknowledgment slides but can't find any for PETSc. I'd appreciate if you could point me to if there is one. > > I take a screen shot of the red text on the lovely cornflower blue backdrop from the website and use that as the logo. > > petsc was created before catchy logos where fashionable. :) (and seemingly developers devote time to coding and not artistic endeavors) As you can see by the other mail we also have no artistic skills :-) > > > Thanks, > Dave > > > Mohammad From rtmills at anl.gov Fri Aug 25 12:52:34 2017 From: rtmills at anl.gov (Richard Tran Mills) Date: Fri, 25 Aug 2017 10:52:34 -0700 Subject: [petsc-users] Logo? In-Reply-To: References: Message-ID: Maybe it's time to make another attempt. Some years ago the PFLOTRAN developers decided we needed a new logo and Glenn Hammond came up with a simple one that I think looks quite nice (see www.pflotran.org). It just has block lettering and some minimal elements like a water table curve that convey a sense of what PFLOTRAN does. Perhaps we can think up something simple like this for PETSc? --Richard On Fri, Aug 25, 2017 at 7:12 AM, Jed Brown wrote: > Haha, there's a reason nobody uses it. ;-) > > Lukas van de Wiel writes: > > > Well, I would rather not use a logo at all than use that design, to be > > honest... > > > > On Fri, Aug 25, 2017 at 3:05 PM, Satish Balay wrote: > > > >> Well we had this logo created many years ago - but I don't remember the > >> last time we used it.. > >> > >> https://bitbucket.org/petsc/petsc/src/15785cf8cfc19332123bc897ee7bf1 > >> 70d1911f0c/src/docs/tex/pictures/petsc_color_logo.jpg? > >> at=master&fileviewer=file-view-default > >> > >> Satish > >> > >> On Fri, 25 Aug 2017, Dave May wrote: > >> > >> > On Fri, 25 Aug 2017 at 03:43, Mohammad Mirzadeh > >> wrote: > >> > > >> > > Hey folks, > >> > > > >> > > Does PETSc have any sort of official logo? > >> > > > >> > > >> > The answer is no > >> > > >> > I often like to include these in my acknowledgment slides but can't > find > >> > > any for PETSc. I'd appreciate if you could point me to if there is > one. > >> > > > >> > > >> > I take a screen shot of the red text on the lovely cornflower blue > >> backdrop > >> > from the website and use that as the logo. > >> > > >> > petsc was created before catchy logos where fashionable. :) (and > >> seemingly > >> > developers devote time to coding and not artistic endeavors) > >> > > >> > > >> > Thanks, > >> > Dave > >> > > >> > > >> > > Mohammad > >> > > > >> > > >> > >> > -------------- next part -------------- An HTML attachment was scrubbed... URL: From jed at jedbrown.org Fri Aug 25 16:05:14 2017 From: jed at jedbrown.org (Jed Brown) Date: Fri, 25 Aug 2017 15:05:14 -0600 Subject: [petsc-users] Logo? In-Reply-To: References: Message-ID: <87shgfjr3p.fsf@jedbrown.org> The natural thing would be to solve a PDE with domain, coefficients, or initial condition being the text "PETSc", then plot a relevant quantity (e.g., stress or vorticity). Richard Tran Mills writes: > Maybe it's time to make another attempt. Some years ago the PFLOTRAN > developers decided we needed a new logo and Glenn Hammond came up with a > simple one that I think looks quite nice (see www.pflotran.org). It just > has block lettering and some minimal elements like a water table curve that > convey a sense of what PFLOTRAN does. Perhaps we can think up something > simple like this for PETSc? > > --Richard > > On Fri, Aug 25, 2017 at 7:12 AM, Jed Brown wrote: > >> Haha, there's a reason nobody uses it. ;-) >> >> Lukas van de Wiel writes: >> >> > Well, I would rather not use a logo at all than use that design, to be >> > honest... >> > >> > On Fri, Aug 25, 2017 at 3:05 PM, Satish Balay wrote: >> > >> >> Well we had this logo created many years ago - but I don't remember the >> >> last time we used it.. >> >> >> >> https://bitbucket.org/petsc/petsc/src/15785cf8cfc19332123bc897ee7bf1 >> >> 70d1911f0c/src/docs/tex/pictures/petsc_color_logo.jpg? >> >> at=master&fileviewer=file-view-default >> >> >> >> Satish >> >> >> >> On Fri, 25 Aug 2017, Dave May wrote: >> >> >> >> > On Fri, 25 Aug 2017 at 03:43, Mohammad Mirzadeh >> >> wrote: >> >> > >> >> > > Hey folks, >> >> > > >> >> > > Does PETSc have any sort of official logo? >> >> > > >> >> > >> >> > The answer is no >> >> > >> >> > I often like to include these in my acknowledgment slides but can't >> find >> >> > > any for PETSc. I'd appreciate if you could point me to if there is >> one. >> >> > > >> >> > >> >> > I take a screen shot of the red text on the lovely cornflower blue >> >> backdrop >> >> > from the website and use that as the logo. >> >> > >> >> > petsc was created before catchy logos where fashionable. :) (and >> >> seemingly >> >> > developers devote time to coding and not artistic endeavors) >> >> > >> >> > >> >> > Thanks, >> >> > Dave >> >> > >> >> > >> >> > > Mohammad >> >> > > >> >> > >> >> >> >> >> -------------- next part -------------- A non-text attachment was scrubbed... Name: signature.asc Type: application/pgp-signature Size: 832 bytes Desc: not available URL: From bsmith at mcs.anl.gov Fri Aug 25 16:56:19 2017 From: bsmith at mcs.anl.gov (Barry Smith) Date: Fri, 25 Aug 2017 14:56:19 -0700 Subject: [petsc-users] Shell matrix MatCreateVecs In-Reply-To: References: Message-ID: Fixed in master, it is MATOP_CREATE_VECS > On Aug 24, 2017, at 1:51 PM, Greg Meyer wrote: > > Hi, > > I have written a shell matrix for non-standard vectors (CUDA to be specific) that works great. MatMult and MatNorm perform as they should. However, when I try to use it in a SLEPc algorithm, it breaks because MatCreateVecs yields standard vectors even if I set "-vec_type cuda". Looking through the source etc. it seems that MatShellSetOperation can't be used to implement a new MatCreateVecs function (MATOP_CREATEVECS does not exist). Is there a way to change the type of vector that comes from MatCreateVecs for shell matrices? > > Thanks in advance, > Greg From bsmith at mcs.anl.gov Sat Aug 26 17:54:18 2017 From: bsmith at mcs.anl.gov (Barry Smith) Date: Sat, 26 Aug 2017 17:54:18 -0500 Subject: [petsc-users] Parallel dense solve with submatrices In-Reply-To: References: Message-ID: Toon, We don't have any such way of doing this. Note that sparse factorization packages store the "factors" in specialized data structures that are unlikely to be acessable to perform such operations as you describe below. I think what you want to do is an over optimization not worth the coding effort. Barry > On Aug 25, 2017, at 5:01 AM, Toon Weyens wrote: > > Dear all, > > For a Bounday Element Method problem I require the solution of a system of linear equations with multiple right-hand sides. Though this is a dense system, I still want to do it via Petsc. Would the best way to do this be through something such as > > -ksp_type preonly -pc_type lu -pc_factor_mat_solver_package mumps ? > > Furthermore, I refine my grid in a regular way, which leads to a new system of equations of size 2N x 2N where N is the original number of unknowns before refining it. The upper-left matrix A_11 in this new system is identical to the unrefined matrix (multiplied by 0.5). The other three blocks A_12, A_21 and A_22 are new: > > A_11 A_12 > A_21 A_22 > > The question is now whether knowledge about the unrefined matrix A_11 can be used to speed up calculation of the refined system? > > I was thinking, for example, about using the LU decomposition of A_11 to calculate the LU decomposition of the entire matrix A using the well-known formula's > > L_21 U_11 = A_21 > L_11 U_12 = A_12 > L_22 U_22 = A_22 - L_21 U_12 > > where L_21 and U_12 are full matrices, L_11, L_22 are lower triangular matrices and U_11, U_22 are upper triangular. > > Is there any way to do this in Petsc? > > Or is there a better thing I can do? > > Thanks very much in advance! > > Regards. > > Dr. Toon Weyens > ITER Organization From zakaryah at gmail.com Sat Aug 26 17:56:26 2017 From: zakaryah at gmail.com (zakaryah .) Date: Sat, 26 Aug 2017 18:56:26 -0400 Subject: [petsc-users] A number of questions about DMDA with SNES and Quasi-Newton methods Message-ID: I'm using PETSc's SNES methods to solve PDEs which result from Euler-Lagrange equations for the strain energy of a 3D displacement field. There is an additional term in the Lagrangian which describes external forces which arise from various data sets, and that term contains nonlinearities (field terms higher than linear). The grid has about 1.6e6 elements, and the displacement field has 3 components at each grid element. I'm trying to solve a sequence of successively more complicated equations, and the latest equation is failing to converge on some data sets. In particular, the methods were successful for the infinitesimal bulk strain (compression) energy, as well as the full infinitesimal strain energy (bulk + shear), but I'm now trying to generalize to the finite strain, as certain data sets are known to result from displacement fields for which the infinitesimal strain is a poor approximation. I'm using a DMDA, closely following example 48, and my preferred solver is L-BFGS. I have read the FAQs "Why is Newton's method not converging? ?" and " Why is my iterative linear solver not converging? ?" ? which have raised a number of questions: Is there documentation for the DMDA/SNES methods somewhere? I don't understand these very well. For example, I am not allocating any matrix for the global Jacobian, and I believe this prevents me from changing the line search. If I'm mistaken I would love to see an example of changing the line search type while using DMDA/SNES. I don't know how to interpret the linesearch monitor. Even for problems which are converging properly, the linesearch monitor reports "lssucceed=0" on every iteration. Is this a problem? I'm also having trouble understanding the methods for troubleshooting. I suspect that I've made an error in the analytical Jacobian, which has a rather large number of non-zero elements, but I have no idea how to use -snes_type test -snes_test_display. The FAQs mention that some troubleshooting tools are more useful for small test problems. How small is small? When I try to run the program with -snes_type test -snes_test_display, I get errors like: [0]PETSC ERROR: Argument out of range [0]PETSC ERROR: Local index 1076396032 too large 4979879 (max) at 0 The second size is 1 less than the number of field elements, while the first number seems too large for any aspect of the problem - the Jacobian has at most 59 non-zero columns per row. Because I suspect a possible error in the Jacobian, I ran with -snes_mf_operator -pc_type ksp -ksp_ksp_rtol 1e-12 and observed very similar failure to converge (diverging residual) as with the explicit Jacobian. Do I need to set an SNES method which is somehow compatible with the "matrix-free" approach? If I instead use -snes_mf, the problem seems to converge, but horrendously slowly (true residual relative decrease by about 1e-5 per iteration). I suppose this supports my suspicion that the Jacobian is incorrect but doesn't really suggest a solution. Is it possible that the analytical Jacobian is correct, but somehow pathological, which causes the SNES to diverge? Neither the Jacobian nor the function have singularities. Thanks for any help you can provide! -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Sat Aug 26 18:38:59 2017 From: bsmith at mcs.anl.gov (Barry Smith) Date: Sat, 26 Aug 2017 18:38:59 -0500 Subject: [petsc-users] A number of questions about DMDA with SNES and Quasi-Newton methods In-Reply-To: References: Message-ID: <020DAED9-AAAD-4741-976B-BB2EF6C79D3F@mcs.anl.gov> > On Aug 26, 2017, at 5:56 PM, zakaryah . wrote: > > I'm using PETSc's SNES methods to solve PDEs which result from Euler-Lagrange equations for the strain energy of a 3D displacement field. There is an additional term in the Lagrangian which describes external forces which arise from various data sets, and that term contains nonlinearities (field terms higher than linear). The grid has about 1.6e6 elements, and the displacement field has 3 components at each grid element. > > I'm trying to solve a sequence of successively more complicated equations, and the latest equation is failing to converge on some data sets. In particular, the methods were successful for the infinitesimal bulk strain (compression) energy, as well as the full infinitesimal strain energy (bulk + shear), but I'm now trying to generalize to the finite strain, as certain data sets are known to result from displacement fields for which the infinitesimal strain is a poor approximation. > > I'm using a DMDA, closely following example 48, and my preferred solver is L-BFGS. So you are using ? -snes_type qn -snes_qn_type lbfgs > > I have read the FAQs "Why is Newton's method not converging??" and "Why is my iterative linear solver not converging??"? which have raised a number of questions: Quasi Newton methods either don't use Jacobians or use only the initial Jacobian (the idea behind quasi-Newton methods is to approximate Jacobian information from previous iterations without having the user compute a Jacobian at each iteration). With PETSc's qn it only uses the Jacobian if you use the option -snes_qn_scale_type Jacobian otherwise the Jacobian is never computed or used > > Is there documentation for the DMDA/SNES methods somewhere? I don't understand these very well. For example, I am not allocating any matrix for the global Jacobian, and I believe this prevents me from changing the line search. If I'm mistaken I would love to see an example of changing the line search type while using DMDA/SNES. Whether you provide a Jacobian or not is orthogonal to the line search. You should be able to change the line search with -snes_linesearch_type bt or nleqerr or basic or l2 or cp not all of them may work with qn > > I don't know how to interpret the linesearch monitor. Even for problems which are converging properly, the linesearch monitor reports "lssucceed=0" on every iteration. Is this a problem? It returns a 0 if the line search does not believe it has achieved "sufficient decrease" in the function norm (or possibly some other measure of decrease) you should run -snes_linesearch_monitor also with the option -snes_monitor to see what is happening to the function norm For qn you can add the option -snes_qn_monitor to get more detailed monitoring > > I'm also having trouble understanding the methods for troubleshooting. I suspect that I've made an error in the analytical Jacobian, which has a rather large number of non-zero elements, but I have no idea how to use -snes_type test -snes_test_display. The FAQs mention that some troubleshooting tools are more useful for small test problems. How small is small? Tiny, at most a few dozen rows and columns in the Jacobin. You should run without the -snes_test_display information, what does it say? Does it indicate the Jacobian or report there is likely a problem? With DMDA you can also use -snes_fd_color to have PETSc compute the Jacobian for you instead of using your analytical form. If it works with this, but not your Jacobian then your Jacobian is wrong. > When I try to run the program with -snes_type test -snes_test_display, I get errors like: > > [0]PETSC ERROR: Argument out of range [0]PETSC ERROR: Local index 1076396032 too large 4979879 (max) at 0 > > The second size is 1 less than the number of field elements, while the first number seems too large for any aspect of the problem - the Jacobian has at most 59 non-zero columns per row. > > Because I suspect a possible error in the Jacobian, I ran with -snes_mf_operator -pc_type ksp -ksp_ksp_rtol 1e-12 and observed very similar failure to converge (diverging residual) as with the explicit Jacobian. What do you get with -ksp_monitor -ksp_ksp_monitor it sounds like the true Jacobian is either very ill-conditioned or your function evaluation is wrong. > Do I need to set an SNES method which is somehow compatible with the "matrix-free" approach? If I instead use -snes_mf, the problem seems to converge, but horrendously slowly (true residual relative decrease by about 1e-5 per iteration). I suppose this supports my suspicion that the Jacobian is incorrect but doesn't really suggest a solution. > > Is it possible that the analytical Jacobian is correct, but somehow pathological, which causes the SNES to diverge? Yes > Neither the Jacobian nor the function have singularities. > > Thanks for any help you can provide! Try really hard to set up a small problem (like just use a very coarse grid) to experiment with as you try to get convergence. Using a big problem for debugging convergence is a recipe for pain. Also since you have a Jacobian I would start with -snes_fd_color -snes_type ls -snes_monitor -snes_linesearch_monitor -ksp_monitor -pc_type lu (not on a huge problem), what happens? Send the output Barry From zakaryah at gmail.com Sat Aug 26 22:43:04 2017 From: zakaryah at gmail.com (zakaryah .) Date: Sat, 26 Aug 2017 23:43:04 -0400 Subject: [petsc-users] A number of questions about DMDA with SNES and Quasi-Newton methods In-Reply-To: <020DAED9-AAAD-4741-976B-BB2EF6C79D3F@mcs.anl.gov> References: <020DAED9-AAAD-4741-976B-BB2EF6C79D3F@mcs.anl.gov> Message-ID: Hi Barry - many thanks for taking the time to understand my many problems and providing so much help. The reason I was concerned that I could not alter the linesearch was when I tried to use bt instead of the L-BFGS default, cp, the code crashed with an error like "Could not get Jacobian". Maybe this is an incompatibility like you say, since L-BFGS only uses the initial Jacobian and I never tried setting the scale type. I took your advice and tried to shrink the problem. First I tried shrinking by a factor 1000 but this converged very quickly with all test data I could provide, including the data which was problematic with the large grid. So I settled for a reduction in size by a factor 125. The grid size is 13,230. This is a decent test case because the solver fails to converge with the options I was using before, and it is small enough that I can run it with the options you suggested (-snes_fd_color -snes_type newtonls -snes_monitor -snes_linesearch_monitor -ksp_monitor -pc_type lu). The output is 1800 lines long - how shall I share it? On Sat, Aug 26, 2017 at 7:38 PM, Barry Smith wrote: > > > On Aug 26, 2017, at 5:56 PM, zakaryah . wrote: > > > > I'm using PETSc's SNES methods to solve PDEs which result from > Euler-Lagrange equations for the strain energy of a 3D displacement field. > There is an additional term in the Lagrangian which describes external > forces which arise from various data sets, and that term contains > nonlinearities (field terms higher than linear). The grid has about 1.6e6 > elements, and the displacement field has 3 components at each grid element. > > > > I'm trying to solve a sequence of successively more complicated > equations, and the latest equation is failing to converge on some data > sets. In particular, the methods were successful for the infinitesimal bulk > strain (compression) energy, as well as the full infinitesimal strain > energy (bulk + shear), but I'm now trying to generalize to the finite > strain, as certain data sets are known to result from displacement fields > for which the infinitesimal strain is a poor approximation. > > > > I'm using a DMDA, closely following example 48, and my preferred solver > is L-BFGS. > > So you are using ? > > -snes_type qn -snes_qn_type lbfgs > > > > > I have read the FAQs "Why is Newton's method not converging??" and "Why > is my iterative linear solver not converging??"? which have raised a number > of questions: > > Quasi Newton methods either don't use Jacobians or use only the initial > Jacobian (the idea behind quasi-Newton methods is to approximate Jacobian > information from previous iterations without having the user compute a > Jacobian at each iteration). With PETSc's qn it only uses the Jacobian if > you use the option > > -snes_qn_scale_type Jacobian > > otherwise the Jacobian is never computed or used > > > > > > Is there documentation for the DMDA/SNES methods somewhere? I don't > understand these very well. For example, I am not allocating any matrix > for the global Jacobian, and I believe this prevents me from changing the > line search. If I'm mistaken I would love to see an example of changing > the line search type while using DMDA/SNES. > > Whether you provide a Jacobian or not is orthogonal to the line search. > > You should be able to change the line search with > > -snes_linesearch_type bt or nleqerr or basic or l2 or cp > > not all of them may work with qn > > > > > > I don't know how to interpret the linesearch monitor. Even for problems > which are converging properly, the linesearch monitor reports "lssucceed=0" > on every iteration. Is this a problem? > > It returns a 0 if the line search does not believe it has achieved > "sufficient decrease" in the function norm (or possibly some other measure > of decrease) you should run -snes_linesearch_monitor also with the option > -snes_monitor to see what is happening to the function norm > > For qn you can add the option > > -snes_qn_monitor > > to get more detailed monitoring > > > > > > I'm also having trouble understanding the methods for troubleshooting. > I suspect that I've made an error in the analytical Jacobian, which has a > rather large number of non-zero elements, but I have no idea how to use > -snes_type test -snes_test_display. The FAQs mention that some > troubleshooting tools are more useful for small test problems. How small > is small? > > Tiny, at most a few dozen rows and columns in the Jacobin. > > You should run without the -snes_test_display information, what does it > say? Does it indicate the Jacobian or report there is likely a problem? > > With DMDA you can also use -snes_fd_color to have PETSc compute the > Jacobian for you instead of using your analytical form. If it works with > this, but not your Jacobian then your Jacobian is wrong. > > > When I try to run the program with -snes_type test -snes_test_display, > I get errors like: > > > > [0]PETSC ERROR: Argument out of range [0]PETSC ERROR: Local index > 1076396032 too large 4979879 (max) at 0 > > > > The second size is 1 less than the number of field elements, while the > first number seems too large for any aspect of the problem - the Jacobian > has at most 59 non-zero columns per row. > > > > Because I suspect a possible error in the Jacobian, I ran with > -snes_mf_operator -pc_type ksp -ksp_ksp_rtol 1e-12 and observed very > similar failure to converge (diverging residual) as with the explicit > Jacobian. > > What do you get with -ksp_monitor -ksp_ksp_monitor it sounds like the > true Jacobian is either very ill-conditioned or your function evaluation is > wrong. > > > Do I need to set an SNES method which is somehow compatible with the > "matrix-free" approach? If I instead use -snes_mf, the problem seems to > converge, but horrendously slowly (true residual relative decrease by about > 1e-5 per iteration). I suppose this supports my suspicion that the > Jacobian is incorrect but doesn't really suggest a solution. > > > > Is it possible that the analytical Jacobian is correct, but somehow > pathological, which causes the SNES to diverge? > > Yes > > > Neither the Jacobian nor the function have singularities. > > > > Thanks for any help you can provide! > > Try really hard to set up a small problem (like just use a very coarse > grid) to experiment with as you try to get convergence. Using a big problem > for debugging convergence is a recipe for pain. > > Also since you have a Jacobian I would start with -snes_fd_color > -snes_type ls -snes_monitor -snes_linesearch_monitor -ksp_monitor -pc_type > lu (not on a huge problem), what happens? Send the output > > Barry > > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Sat Aug 26 22:45:00 2017 From: bsmith at mcs.anl.gov (Barry Smith) Date: Sat, 26 Aug 2017 22:45:00 -0500 Subject: [petsc-users] A number of questions about DMDA with SNES and Quasi-Newton methods In-Reply-To: References: <020DAED9-AAAD-4741-976B-BB2EF6C79D3F@mcs.anl.gov> Message-ID: <5BF530F6-8D79-47E6-B2C5-B0702FF2AA59@mcs.anl.gov> > On Aug 26, 2017, at 10:43 PM, zakaryah . wrote: > > Hi Barry - many thanks for taking the time to understand my many problems and providing so much help. > > The reason I was concerned that I could not alter the linesearch was when I tried to use bt instead of the L-BFGS default, cp, the code crashed with an error like "Could not get Jacobian". Maybe this is an incompatibility like you say, since L-BFGS only uses the initial Jacobian and I never tried setting the scale type. > > I took your advice and tried to shrink the problem. First I tried shrinking by a factor 1000 but this converged very quickly with all test data I could provide, including the data which was problematic with the large grid. So I settled for a reduction in size by a factor 125. The grid size is 13,230. This is a decent test case because the solver fails to converge with the options I was using before, and it is small enough that I can run it with the options you suggested (-snes_fd_color -snes_type newtonls -snes_monitor -snes_linesearch_monitor -ksp_monitor -pc_type lu). > > The output is 1800 lines long - how shall I share it? Just email it, that is small enough for email. Barry > > > > > On Sat, Aug 26, 2017 at 7:38 PM, Barry Smith wrote: > > > On Aug 26, 2017, at 5:56 PM, zakaryah . wrote: > > > > I'm using PETSc's SNES methods to solve PDEs which result from Euler-Lagrange equations for the strain energy of a 3D displacement field. There is an additional term in the Lagrangian which describes external forces which arise from various data sets, and that term contains nonlinearities (field terms higher than linear). The grid has about 1.6e6 elements, and the displacement field has 3 components at each grid element. > > > > I'm trying to solve a sequence of successively more complicated equations, and the latest equation is failing to converge on some data sets. In particular, the methods were successful for the infinitesimal bulk strain (compression) energy, as well as the full infinitesimal strain energy (bulk + shear), but I'm now trying to generalize to the finite strain, as certain data sets are known to result from displacement fields for which the infinitesimal strain is a poor approximation. > > > > I'm using a DMDA, closely following example 48, and my preferred solver is L-BFGS. > > So you are using ? > > -snes_type qn -snes_qn_type lbfgs > > > > > I have read the FAQs "Why is Newton's method not converging??" and "Why is my iterative linear solver not converging??"? which have raised a number of questions: > > Quasi Newton methods either don't use Jacobians or use only the initial Jacobian (the idea behind quasi-Newton methods is to approximate Jacobian information from previous iterations without having the user compute a Jacobian at each iteration). With PETSc's qn it only uses the Jacobian if you use the option > > -snes_qn_scale_type Jacobian > > otherwise the Jacobian is never computed or used > > > > > > Is there documentation for the DMDA/SNES methods somewhere? I don't understand these very well. For example, I am not allocating any matrix for the global Jacobian, and I believe this prevents me from changing the line search. If I'm mistaken I would love to see an example of changing the line search type while using DMDA/SNES. > > Whether you provide a Jacobian or not is orthogonal to the line search. > > You should be able to change the line search with > > -snes_linesearch_type bt or nleqerr or basic or l2 or cp > > not all of them may work with qn > > > > > > I don't know how to interpret the linesearch monitor. Even for problems which are converging properly, the linesearch monitor reports "lssucceed=0" on every iteration. Is this a problem? > > It returns a 0 if the line search does not believe it has achieved "sufficient decrease" in the function norm (or possibly some other measure of decrease) you should run -snes_linesearch_monitor also with the option -snes_monitor to see what is happening to the function norm > > For qn you can add the option > > -snes_qn_monitor > > to get more detailed monitoring > > > > > > I'm also having trouble understanding the methods for troubleshooting. I suspect that I've made an error in the analytical Jacobian, which has a rather large number of non-zero elements, but I have no idea how to use -snes_type test -snes_test_display. The FAQs mention that some troubleshooting tools are more useful for small test problems. How small is small? > > Tiny, at most a few dozen rows and columns in the Jacobin. > > You should run without the -snes_test_display information, what does it say? Does it indicate the Jacobian or report there is likely a problem? > > With DMDA you can also use -snes_fd_color to have PETSc compute the Jacobian for you instead of using your analytical form. If it works with this, but not your Jacobian then your Jacobian is wrong. > > > When I try to run the program with -snes_type test -snes_test_display, I get errors like: > > > > [0]PETSC ERROR: Argument out of range [0]PETSC ERROR: Local index 1076396032 too large 4979879 (max) at 0 > > > > The second size is 1 less than the number of field elements, while the first number seems too large for any aspect of the problem - the Jacobian has at most 59 non-zero columns per row. > > > > Because I suspect a possible error in the Jacobian, I ran with -snes_mf_operator -pc_type ksp -ksp_ksp_rtol 1e-12 and observed very similar failure to converge (diverging residual) as with the explicit Jacobian. > > What do you get with -ksp_monitor -ksp_ksp_monitor it sounds like the true Jacobian is either very ill-conditioned or your function evaluation is wrong. > > > Do I need to set an SNES method which is somehow compatible with the "matrix-free" approach? If I instead use -snes_mf, the problem seems to converge, but horrendously slowly (true residual relative decrease by about 1e-5 per iteration). I suppose this supports my suspicion that the Jacobian is incorrect but doesn't really suggest a solution. > > > > Is it possible that the analytical Jacobian is correct, but somehow pathological, which causes the SNES to diverge? > > Yes > > > Neither the Jacobian nor the function have singularities. > > > > Thanks for any help you can provide! > > Try really hard to set up a small problem (like just use a very coarse grid) to experiment with as you try to get convergence. Using a big problem for debugging convergence is a recipe for pain. > > Also since you have a Jacobian I would start with -snes_fd_color -snes_type ls -snes_monitor -snes_linesearch_monitor -ksp_monitor -pc_type lu (not on a huge problem), what happens? Send the output > > Barry > > > From zakaryah at gmail.com Sat Aug 26 22:48:08 2017 From: zakaryah at gmail.com (zakaryah .) Date: Sat, 26 Aug 2017 23:48:08 -0400 Subject: [petsc-users] A number of questions about DMDA with SNES and Quasi-Newton methods In-Reply-To: <5BF530F6-8D79-47E6-B2C5-B0702FF2AA59@mcs.anl.gov> References: <020DAED9-AAAD-4741-976B-BB2EF6C79D3F@mcs.anl.gov> <5BF530F6-8D79-47E6-B2C5-B0702FF2AA59@mcs.anl.gov> Message-ID: Here's the output, from the data set which does not converge with l-bfgs: 0 SNES Function norm 1.370293318432e+04 0 KSP Residual norm 7.457506389218e+02 1 KSP Residual norm 2.244764079994e-10 Line search: gnorm after quadratic fit 6.541298279196e+05 Line search: Cubic step no good, shrinking lambda, current gnorm 8.963717927372e+04 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.788909416707e+04 lambda=2.5000000000000001e-02 Line search: Cubically determined step, current gnorm 1.340565762719e+04 lambda=1.2500000000000001e-02 1 SNES Function norm 1.340565762719e+04 0 KSP Residual norm 4.096066553372e+02 1 KSP Residual norm 3.313671167444e-11 Line search: gnorm after quadratic fit 1.113749573695e+06 Line search: Cubic step no good, shrinking lambda, current gnorm 1.406390140546e+05 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 2.126781917443e+04 lambda=2.5000000000000001e-02 Line search: Cubically determined step, current gnorm 1.272988597973e+04 lambda=1.2500000000000001e-02 2 SNES Function norm 1.272988597973e+04 0 KSP Residual norm 8.291344597817e+01 1 KSP Residual norm 7.182258362182e-12 Line search: gnorm after quadratic fit 1.121913743889e+04 Line search: Quadratically determined step, lambda=1.0000000000000001e-01 3 SNES Function norm 1.121913743889e+04 0 KSP Residual norm 6.830535877014e+01 1 KSP Residual norm 3.629826411580e-12 Line search: gnorm after quadratic fit 9.966344973786e+03 Line search: Quadratically determined step, lambda=1.0000000000000001e-01 4 SNES Function norm 9.966344973786e+03 0 KSP Residual norm 5.137691531345e+01 1 KSP Residual norm 1.954502098181e-12 Line search: gnorm after quadratic fit 8.905508641232e+03 Line search: Quadratically determined step, lambda=1.0000000000000001e-01 5 SNES Function norm 8.905508641232e+03 0 KSP Residual norm 4.295019262963e+01 1 KSP Residual norm 1.581527994925e-12 Line search: gnorm after quadratic fit 7.599173694189e+03 Line search: Quadratically determined step, lambda=1.4157226463489950e-01 6 SNES Function norm 7.599173694189e+03 0 KSP Residual norm 3.520472291520e+01 1 KSP Residual norm 1.169994130568e-12 Line search: gnorm after quadratic fit 6.797214843928e+03 Line search: Quadratically determined step, lambda=1.0000000000000001e-01 7 SNES Function norm 6.797214843928e+03 0 KSP Residual norm 2.683523206056e+01 1 KSP Residual norm 9.039858014119e-13 Line search: gnorm after quadratic fit 6.098038917364e+03 Line search: Quadratically determined step, lambda=1.0000000000000001e-01 8 SNES Function norm 6.098038917364e+03 0 KSP Residual norm 2.300710560681e+01 1 KSP Residual norm 1.010402303464e-12 Line search: gnorm after quadratic fit 5.486151385552e+03 Line search: Quadratically determined step, lambda=1.0000000000000001e-01 9 SNES Function norm 5.486151385552e+03 0 KSP Residual norm 2.824628827619e+01 1 KSP Residual norm 1.009589866569e-12 Line search: gnorm after quadratic fit 4.964991021247e+03 Line search: Quadratically determined step, lambda=1.0000000000000001e-01 10 SNES Function norm 4.964991021247e+03 0 KSP Residual norm 6.285926028595e+01 1 KSP Residual norm 2.833546214180e-12 Line search: gnorm after quadratic fit 2.100041391472e+04 Line search: Cubic step no good, shrinking lambda, current gnorm 5.804051080767e+03 lambda=5.0000000000000003e-02 Line search: Cubically determined step, current gnorm 4.893296169579e+03 lambda=2.5000000000000001e-02 11 SNES Function norm 4.893296169579e+03 0 KSP Residual norm 1.688978282804e+01 1 KSP Residual norm 5.927677470786e-13 Line search: gnorm after quadratic fit 4.400894622431e+03 Line search: Quadratically determined step, lambda=1.0000000000000001e-01 12 SNES Function norm 4.400894622431e+03 0 KSP Residual norm 1.481197699600e+01 1 KSP Residual norm 4.522572128105e-13 Line search: Using full step: fnorm 4.400894622431e+03 gnorm 2.094971849007e+03 13 SNES Function norm 2.094971849007e+03 0 KSP Residual norm 3.514164563318e+00 1 KSP Residual norm 3.022385947499e-13 Line search: gnorm after quadratic fit 1.687641025382e+03 Line search: Quadratically determined step, lambda=2.0307116693368590e-01 14 SNES Function norm 1.687641025382e+03 0 KSP Residual norm 2.138591884686e+00 1 KSP Residual norm 4.023500814078e-14 Line search: Using full step: fnorm 1.687641025382e+03 gnorm 1.131934218470e+03 15 SNES Function norm 1.131934218470e+03 0 KSP Residual norm 3.245035110327e+00 1 KSP Residual norm 1.293626215269e-13 Line search: Using full step: fnorm 1.131934218470e+03 gnorm 7.340573607307e+02 16 SNES Function norm 7.340573607307e+02 0 KSP Residual norm 1.957698957904e+00 1 KSP Residual norm 3.444648967078e-13 Line search: Using full step: fnorm 7.340573607307e+02 gnorm 5.024723505168e+02 17 SNES Function norm 5.024723505168e+02 0 KSP Residual norm 2.510538703839e+00 1 KSP Residual norm 8.570440675253e-14 Line search: gnorm after quadratic fit 4.548776456608e+02 Line search: Quadratically determined step, lambda=1.0000000000000001e-01 18 SNES Function norm 4.548776456608e+02 0 KSP Residual norm 6.741705718178e-01 1 KSP Residual norm 1.650556120809e-14 Line search: Using full step: fnorm 4.548776456608e+02 gnorm 1.351189086642e+02 19 SNES Function norm 1.351189086642e+02 0 KSP Residual norm 7.653741241950e+00 1 KSP Residual norm 8.326848236950e-14 Line search: gnorm after quadratic fit 4.215455105006e+02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.889750369356e+02 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.358691836999e+02 lambda=1.0303015930243279e-02 Line search: Cubically determined step, current gnorm 1.348911963390e+02 lambda=3.5279526770504110e-03 20 SNES Function norm 1.348911963390e+02 0 KSP Residual norm 4.209281176918e+00 1 KSP Residual norm 1.233232881375e-13 Line search: gnorm after quadratic fit 1.860023264470e+02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.413911132196e+02 lambda=5.0000000000000003e-02 Line search: Cubically determined step, current gnorm 1.339597869053e+02 lambda=1.5787957598629023e-02 21 SNES Function norm 1.339597869053e+02 0 KSP Residual norm 1.718484765841e+00 1 KSP Residual norm 6.666016296543e-14 Line search: gnorm after quadratic fit 1.326878521472e+02 Line search: Quadratically determined step, lambda=1.0000000000000001e-01 22 SNES Function norm 1.326878521472e+02 0 KSP Residual norm 1.515373499919e+00 1 KSP Residual norm 2.259154130795e-12 Line search: gnorm after quadratic fit 1.226907316391e+02 Line search: Quadratically determined step, lambda=1.0000000000000001e-01 23 SNES Function norm 1.226907316391e+02 0 KSP Residual norm 1.080252936903e+00 1 KSP Residual norm 1.847020526683e-14 Line search: gnorm after quadratic fit 1.163632111851e+02 Line search: Quadratically determined step, lambda=1.0000000000000001e-01 24 SNES Function norm 1.163632111851e+02 0 KSP Residual norm 2.491746958382e+00 1 KSP Residual norm 6.389134193637e-14 Line search: gnorm after quadratic fit 1.345487153563e+02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.169738363622e+02 lambda=4.4108900954515480e-02 Line search: Cubically determined step, current gnorm 1.152177638108e+02 lambda=1.9997442889243631e-02 25 SNES Function norm 1.152177638108e+02 0 KSP Residual norm 5.364385501004e+00 1 KSP Residual norm 8.457149562463e-14 Line search: gnorm after quadratic fit 2.722095758964e+02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.480946353374e+02 lambda=5.0000000000000003e-02 Line search: Cubically determined step, current gnorm 1.150680255994e+02 lambda=6.3560128131639167e-03 26 SNES Function norm 1.150680255994e+02 0 KSP Residual norm 4.302025268263e+00 1 KSP Residual norm 1.017526937941e-13 Line search: gnorm after quadratic fit 1.956300983573e+02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.318600522939e+02 lambda=5.0000000000000003e-02 Line search: Cubically determined step, current gnorm 1.147123505014e+02 lambda=7.6060788653548803e-03 27 SNES Function norm 1.147123505014e+02 0 KSP Residual norm 6.195463111324e+00 1 KSP Residual norm 1.235283250361e-13 Line search: gnorm after quadratic fit 3.324821547049e+02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.612593208504e+02 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.147389525772e+02 lambda=6.1750939181374294e-03 Line search: Cubically determined step, current gnorm 1.145411432123e+02 lambda=3.0078592586792975e-03 28 SNES Function norm 1.145411432123e+02 0 KSP Residual norm 1.454704250187e+01 1 KSP Residual norm 2.368485174123e-13 Line search: gnorm after quadratic fit 1.216293873116e+03 Line search: Cubic step no good, shrinking lambda, current gnorm 3.796524621727e+02 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.359314163651e+02 lambda=1.4867675803955788e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.146009802557e+02 lambda=1.4867675803955788e-03 Line search: Cubically determined step, current gnorm 1.145096815033e+02 lambda=5.5250912472932839e-04 29 SNES Function norm 1.145096815033e+02 0 KSP Residual norm 3.430451345093e+01 1 KSP Residual norm 1.069396165938e-12 Line search: gnorm after quadratic fit 1.161329407098e+04 Line search: Cubic step no good, shrinking lambda, current gnorm 2.260690718050e+03 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 5.696806489042e+02 lambda=2.5000000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.960149915648e+02 lambda=1.1276129246469476e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.158113641658e+02 lambda=1.5873910451430554e-03 Line search: Cubically determined step, current gnorm 1.145062232916e+02 lambda=1.5873910451430555e-04 30 SNES Function norm 1.145062232916e+02 0 KSP Residual norm 2.662578971526e+01 1 KSP Residual norm 5.464011789728e-13 Line search: gnorm after quadratic fit 4.375119254490e+03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.038018103928e+03 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 3.169328002874e+02 lambda=2.3789161387159519e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.262835432714e+02 lambda=5.9737415571960795e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.145626045197e+02 lambda=5.9737415571960802e-04 Line search: Cubically determined step, current gnorm 1.144968604079e+02 lambda=1.6421773527706333e-04 31 SNES Function norm 1.144968604079e+02 0 KSP Residual norm 6.322033697338e+01 1 KSP Residual norm 1.507157991448e-12 Line search: gnorm after quadratic fit 5.809243699277e+04 Line search: Cubic step no good, shrinking lambda, current gnorm 9.460487584142e+03 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.893183483197e+03 lambda=2.5000000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 4.960337007072e+02 lambda=1.2500000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.771527792790e+02 lambda=5.3912931685137378e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.150137639707e+02 lambda=5.3912931685137376e-04 Line search: Cubically determined step, current gnorm 1.144964484571e+02 lambda=5.3912931685137380e-05 32 SNES Function norm 1.144964484571e+02 0 KSP Residual norm 3.859510930996e+01 1 KSP Residual norm 8.069118044382e-13 Line search: gnorm after quadratic fit 1.106329930525e+04 Line search: Cubic step no good, shrinking lambda, current gnorm 2.155884463041e+03 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 5.933963819094e+02 lambda=2.5000000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.849629797377e+02 lambda=9.7744286136270241e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.150857687050e+02 lambda=9.7744286136270254e-04 Line search: Cubically determined step, current gnorm 1.144922906340e+02 lambda=9.7744286136270254e-05 33 SNES Function norm 1.144922906340e+02 0 KSP Residual norm 4.952038022394e+01 1 KSP Residual norm 7.460263245424e-13 Line search: gnorm after quadratic fit 3.005091127220e+04 Line search: Cubic step no good, shrinking lambda, current gnorm 5.229308416025e+03 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.138600794682e+03 lambda=2.5000000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 3.390856262238e+02 lambda=1.2500000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.394997214983e+02 lambda=4.4582997750629580e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.146836358799e+02 lambda=4.4582997750629581e-04 Line search: Cubically determined step, current gnorm 1.144895966587e+02 lambda=4.7644082443915877e-05 34 SNES Function norm 1.144895966587e+02 0 KSP Residual norm 1.146914786457e+02 1 KSP Residual norm 4.791627042400e-12 Line search: gnorm after quadratic fit 2.601294145944e+05 Line search: Cubic step no good, shrinking lambda, current gnorm 3.324148513778e+04 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 5.247478406023e+03 lambda=2.5000000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.200340900661e+03 lambda=1.2500000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 3.696223112300e+02 lambda=6.1514413845115794e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.342365431983e+02 lambda=1.7502929694284564e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.146686063035e+02 lambda=1.7502929694284566e-04 Line search: Cubically determined step, current gnorm 1.144895868489e+02 lambda=1.7502929694284566e-05 35 SNES Function norm 1.144895868489e+02 0 KSP Residual norm 6.311017209658e+01 1 KSP Residual norm 8.384445939117e-13 Line search: gnorm after quadratic fit 5.781533400572e+04 Line search: Cubic step no good, shrinking lambda, current gnorm 9.419557746031e+03 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.886081770030e+03 lambda=2.5000000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 4.945810143740e+02 lambda=1.2500000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.767820854837e+02 lambda=5.3859001959289735e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.150034040559e+02 lambda=5.3859001959289732e-04 Line search: Cubically determined step, current gnorm 1.144891501665e+02 lambda=5.3859001959289732e-05 36 SNES Function norm 1.144891501665e+02 0 KSP Residual norm 3.880748384332e+01 1 KSP Residual norm 6.400339290453e-13 Line search: gnorm after quadratic fit 1.122504184426e+04 Line search: Cubic step no good, shrinking lambda, current gnorm 2.180728237366e+03 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 5.987870621566e+02 lambda=2.5000000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.863711604331e+02 lambda=9.8150771384688824e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.150916783781e+02 lambda=9.8150771384688824e-04 Line search: Cubically determined step, current gnorm 1.144850837411e+02 lambda=9.8150771384688832e-05 37 SNES Function norm 1.144850837411e+02 0 KSP Residual norm 4.811537498557e+01 1 KSP Residual norm 9.738167670242e-13 Line search: gnorm after quadratic fit 2.784098355218e+04 Line search: Cubic step no good, shrinking lambda, current gnorm 4.885118868254e+03 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.074843354348e+03 lambda=2.5000000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 3.255202820836e+02 lambda=1.2500000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.365202996130e+02 lambda=4.3204204582016374e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.146504919412e+02 lambda=4.3204204582016374e-04 Line search: Cubically determined step, current gnorm 1.144822306241e+02 lambda=5.0376546850227848e-05 38 SNES Function norm 1.144822306241e+02 0 KSP Residual norm 1.120914002482e+02 1 KSP Residual norm 5.452125292284e-12 Line search: gnorm after quadratic fit 2.427186680567e+05 Line search: Cubic step no good, shrinking lambda, current gnorm 3.112196656857e+04 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 4.967397366072e+03 lambda=2.5000000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.149551659770e+03 lambda=1.2500000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 3.529630886791e+02 lambda=6.0885216927030559e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.315267519231e+02 lambda=1.6656233536183130e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.146353659250e+02 lambda=1.6656233536183130e-04 Line search: Cubically determined step, current gnorm 1.144820487391e+02 lambda=1.6656233536183130e-05 39 SNES Function norm 1.144820487391e+02 0 KSP Residual norm 7.182416170980e+01 1 KSP Residual norm 1.292147133333e-12 Line search: gnorm after quadratic fit 8.255331293322e+04 Line search: Cubic step no good, shrinking lambda, current gnorm 1.302939895170e+04 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 2.501228089911e+03 lambda=2.5000000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 6.185010378583e+02 lambda=1.2500000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 2.088179821424e+02 lambda=5.7489510178867142e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.168272901121e+02 lambda=9.7452649444612811e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 1.144951972300e+02 lambda=9.7452649444612822e-05 Line search: Cubically determined step, current gnorm 1.144807676687e+02 lambda=2.2399506502463798e-05 40 SNES Function norm 1.144807676687e+02 0 KSP Residual norm 1.728679810285e+02 1 KSP Residual norm 3.878068639716e-12 Line search: gnorm after quadratic fit 9.011020578535e+05 Line search: Cubic step no good, shrinking lambda, current gnorm 1.111818830011e+05 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.504789858103e+04 lambda=2.5000000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 2.754312133162e+03 lambda=1.2500000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 7.212492111975e+02 lambda=6.2500000000000003e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 2.199969180537e+02 lambda=2.6424184504193135e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.154794639440e+02 lambda=2.6424184504193136e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 1.144880673342e+02 lambda=2.6424184504193136e-05 Line search: Cubically determined step, current gnorm 1.144805461570e+02 lambda=3.8712107591125690e-06 41 SNES Function norm 1.144805461570e+02 0 KSP Residual norm 4.162780846202e+02 1 KSP Residual norm 1.732341544934e-11 Line search: gnorm after quadratic fit 1.355673864369e+07 Line search: Cubic step no good, shrinking lambda, current gnorm 1.747523002884e+06 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 2.342205048417e+05 lambda=2.5000000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 3.425635699680e+04 lambda=1.2500000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 5.882150659178e+03 lambda=6.2500000000000003e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.259664786336e+03 lambda=3.1250000000000002e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 3.653670676209e+02 lambda=1.5625000000000001e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.453655830144e+02 lambda=5.8237455565260388e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 1.147659525018e+02 lambda=5.8237455565260393e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 1.144827915995e+02 lambda=5.8237455565260400e-06 Line search: Cubically determined step, current gnorm 1.144805080017e+02 lambda=6.6689295146509104e-07 42 SNES Function norm 1.144805080017e+02 0 KSP Residual norm 1.004135512581e+03 1 KSP Residual norm 3.867626041000e-09 Line search: gnorm after quadratic fit 1.832578994882e+08 Line search: Cubic step no good, shrinking lambda, current gnorm 2.269698278878e+07 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 2.792476589915e+06 lambda=2.5000000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 3.420660371083e+05 lambda=1.2500000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 4.321686926168e+04 lambda=6.2500000000000003e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 6.548358078234e+03 lambda=3.1250000000000002e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.429504802276e+03 lambda=1.5625000000000001e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 4.317723385004e+02 lambda=7.8125000000000004e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 1.460079723095e+02 lambda=2.5078917343692407e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 1.147908977725e+02 lambda=2.5078917343692408e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 1.144833604238e+02 lambda=2.5078917343692412e-06 Line search: Cubic step no good, shrinking lambda, current gnorm 1.144805106824e+02 lambda=2.5078917343692411e-07 Line search: Cubically determined step, current gnorm 1.144805014337e+02 lambda=1.1468707119027746e-07 43 SNES Function norm 1.144805014337e+02 0 KSP Residual norm 2.418614573592e+03 1 KSP Residual norm 6.085078742847e-10 Line search: gnorm after quadratic fit 2.598476259775e+09 Line search: Cubic step no good, shrinking lambda, current gnorm 3.262759415873e+08 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 4.116845970403e+07 lambda=2.5000000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 5.250465130250e+06 lambda=1.2500000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 6.863493884574e+05 lambda=6.2500000000000003e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 9.501468163771e+04 lambda=3.1250000000000002e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.482658980483e+04 lambda=1.5625000000000001e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 2.802395557883e+03 lambda=7.8125000000000004e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 6.788149582374e+02 lambda=3.9062500000000002e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 2.248828337038e+02 lambda=1.8333058767960295e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 1.186285836222e+02 lambda=3.7550993478654105e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 1.145209710139e+02 lambda=3.7550993478654107e-06 Line search: Cubic step no good, shrinking lambda, current gnorm 1.144808670668e+02 lambda=3.7550993478654111e-07 Line search: Cubically determined step, current gnorm 1.144805012252e+02 lambda=3.7550993478654114e-08 44 SNES Function norm 1.144805012252e+02 0 KSP Residual norm 1.432476672735e+03 1 KSP Residual norm 7.850524783892e-11 Line search: gnorm after quadratic fit 5.336191593632e+08 Line search: Cubic step no good, shrinking lambda, current gnorm 6.625576866625e+07 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 8.181408387845e+06 lambda=2.5000000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.003310644422e+06 lambda=1.2500000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.236384273292e+05 lambda=6.2500000000000003e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.658430638069e+04 lambda=3.1250000000000002e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 2.977463068161e+03 lambda=1.5625000000000001e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 7.674238499253e+02 lambda=7.8125000000000004e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 2.333616820791e+02 lambda=3.3764776729281175e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 1.161349153752e+02 lambda=4.0497161764116874e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 1.144966925969e+02 lambda=4.0497161764116874e-06 Line search: Cubic step no good, shrinking lambda, current gnorm 1.144806214839e+02 lambda=4.0497161764116878e-07 Line search: Cubically determined step, current gnorm 1.144804979966e+02 lambda=5.6339112427782378e-08 45 SNES Function norm 1.144804979966e+02 0 KSP Residual norm 3.453401579761e+03 1 KSP Residual norm 4.197968028126e-09 Line search: gnorm after quadratic fit 7.554006183767e+09 Line search: Cubic step no good, shrinking lambda, current gnorm 9.471974940372e+08 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.191613865049e+08 lambda=2.5000000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.509784334249e+07 lambda=1.2500000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.943752478560e+06 lambda=6.2500000000000003e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 2.597601716755e+05 lambda=3.1250000000000002e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 3.775572331075e+04 lambda=1.5625000000000001e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 6.418045407608e+03 lambda=7.8125000000000004e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 1.357066758731e+03 lambda=3.9062500000000002e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 3.859267839080e+02 lambda=1.9531250000000001e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 1.501494912160e+02 lambda=7.5160826909319168e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 1.148144926477e+02 lambda=7.5160826909319171e-06 Line search: Cubic step no good, shrinking lambda, current gnorm 1.144837498478e+02 lambda=7.5160826909319179e-07 Line search: Cubic step no good, shrinking lambda, current gnorm 1.144805227746e+02 lambda=7.5160826909319182e-08 Line search: Cubically determined step, current gnorm 1.144804974438e+02 lambda=9.6864021663644795e-09 46 SNES Function norm 1.144804974438e+02 0 KSP Residual norm 8.345139428850e+03 1 KSP Residual norm 1.027819754739e-09 Line search: gnorm after quadratic fit 1.061319903906e+11 Line search: Cubic step no good, shrinking lambda, current gnorm 1.325012985379e+10 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.652236226640e+09 lambda=2.5000000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 2.055533971630e+08 lambda=1.2500000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 2.546607716763e+07 lambda=6.2500000000000003e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 3.134442858835e+06 lambda=3.1250000000000002e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 3.839168570687e+05 lambda=1.5625000000000001e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 4.830568178626e+04 lambda=7.8125000000000004e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 7.201776786081e+03 lambda=3.9062500000000002e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 1.540520468013e+03 lambda=1.9531250000000001e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 4.573504890506e+02 lambda=9.7656250000000005e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 1.516203908013e+02 lambda=3.2703670177372021e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 1.148480075676e+02 lambda=3.2703670177372022e-06 Line search: Cubic step no good, shrinking lambda, current gnorm 1.144841475328e+02 lambda=3.2703670177372023e-07 Line search: Cubic step no good, shrinking lambda, current gnorm 1.144805305720e+02 lambda=3.2703670177372021e-08 Line search: Cubically determined step, current gnorm 1.144804974367e+02 lambda=3.2703670177372025e-09 47 SNES Function norm 1.144804974367e+02 0 KSP Residual norm 4.668983500382e+03 1 KSP Residual norm 1.398997665317e-09 Line search: gnorm after quadratic fit 1.865309565532e+10 Line search: Cubic step no good, shrinking lambda, current gnorm 2.336975299727e+09 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 2.934905088739e+08 lambda=2.5000000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 3.704520478641e+07 lambda=1.2500000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 4.728477809448e+06 lambda=6.2500000000000003e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 6.193001670096e+05 lambda=3.1250000000000002e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 8.610673238239e+04 lambda=1.5625000000000001e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.354711683605e+04 lambda=7.8125000000000004e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 2.589557246433e+03 lambda=3.9062500000000002e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 6.367851970709e+02 lambda=1.9531250000000001e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 2.136930269795e+02 lambda=9.0316845802227864e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 1.172186635069e+02 lambda=1.5831613287181393e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 1.145074017254e+02 lambda=1.5831613287181394e-06 Line search: Cubic step no good, shrinking lambda, current gnorm 1.144807499816e+02 lambda=1.5831613287181396e-07 Line search: Cubic step no good, shrinking lambda, current gnorm 1.144804983345e+02 lambda=1.5831613287181397e-08 Line search: Cubically determined step, current gnorm 1.144804971346e+02 lambda=5.2932921109871310e-09 48 SNES Function norm 1.144804971346e+02 0 KSP Residual norm 1.132678078317e+04 1 KSP Residual norm 2.477518733314e-10 Line search: gnorm after quadratic fit 2.654659022365e+11 Line search: Cubic step no good, shrinking lambda, current gnorm 3.315296223725e+10 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 4.136635677074e+09 lambda=2.5000000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 5.152507060235e+08 lambda=1.2500000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 6.397060094478e+07 lambda=6.2500000000000003e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 7.898362012287e+06 lambda=3.1250000000000002e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 9.685179520906e+05 lambda=1.5625000000000001e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.194040779842e+05 lambda=7.8125000000000004e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 1.606415730227e+04 lambda=3.9062500000000002e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 2.902698091972e+03 lambda=1.9531250000000001e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 7.521549384652e+02 lambda=9.7656250000000005e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 2.288999778994e+02 lambda=4.1899746703195281e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 1.157880829786e+02 lambda=4.5470218451893824e-06 Line search: Cubic step no good, shrinking lambda, current gnorm 1.144935741206e+02 lambda=4.5470218451893828e-07 Line search: Cubic step no good, shrinking lambda, current gnorm 1.144806232638e+02 lambda=4.5470218451893831e-08 Line search: Cubic step no good, shrinking lambda, current gnorm 1.144804979250e+02 lambda=4.5470218451893835e-09 Line search: Cubically determined step, current gnorm 1.144804970825e+02 lambda=9.0293679903918216e-10 49 SNES Function norm 1.144804970825e+02 0 KSP Residual norm 2.712544829144e+04 1 KSP Residual norm 4.949246309677e-09 Line search: gnorm after quadratic fit 3.650846005745e+12 Line search: Cubic step no good, shrinking lambda, current gnorm 4.565321055911e+11 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 5.711080201118e+10 lambda=2.5000000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 7.150022242308e+09 lambda=1.2500000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 8.965954117985e+08 lambda=6.2500000000000003e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.128096393645e+08 lambda=3.1250000000000002e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.429702091584e+07 lambda=1.5625000000000001e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.841819946536e+06 lambda=7.8125000000000004e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 2.465032956946e+05 lambda=3.9062500000000002e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 3.594210253794e+04 lambda=1.9531250000000001e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 6.141110278944e+03 lambda=9.7656250000000005e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 1.306952279045e+03 lambda=4.8828125000000003e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 3.754164864338e+02 lambda=2.4414062500000001e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 1.476861367158e+02 lambda=9.2451761406722810e-06 Line search: Cubic step no good, shrinking lambda, current gnorm 1.147929263780e+02 lambda=9.2451761406722810e-07 Line search: Cubic step no good, shrinking lambda, current gnorm 1.144836022952e+02 lambda=9.2451761406722821e-08 Line search: Cubic step no good, shrinking lambda, current gnorm 1.144805271860e+02 lambda=9.2451761406722831e-09 Line search: Cubic step no good, shrinking lambda, current gnorm 1.144804972895e+02 lambda=9.2451761406722839e-10 Line search: Cubically determined step, current gnorm 1.144804970737e+02 lambda=1.5633616333063305e-10 50 SNES Function norm 1.144804970737e+02 0 SNES Function norm 2.308693894796e+03 0 KSP Residual norm 8.981999720532e+00 1 KSP Residual norm 2.363170936183e-13 Line search: Using full step: fnorm 2.308693894796e+03 gnorm 7.571661187318e+02 1 SNES Function norm 7.571661187318e+02 0 KSP Residual norm 2.149614048903e+00 1 KSP Residual norm 9.511247057888e-13 Line search: Using full step: fnorm 7.571661187318e+02 gnorm 4.450081004997e+02 2 SNES Function norm 4.450081004997e+02 0 KSP Residual norm 1.706469075123e+01 1 KSP Residual norm 5.803815175472e-13 Line search: gnorm after quadratic fit 1.510518198899e+03 Line search: Cubic step no good, shrinking lambda, current gnorm 5.850796532980e+02 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 4.515983139755e+02 lambda=2.0602556887689423e-02 Line search: Cubically determined step, current gnorm 4.434800867235e+02 lambda=8.2396279492937211e-03 3 SNES Function norm 4.434800867235e+02 0 KSP Residual norm 3.208587171626e+00 1 KSP Residual norm 1.099072610659e-13 Line search: gnorm after quadratic fit 4.080637194736e+02 Line search: Quadratically determined step, lambda=1.0000000000000001e-01 4 SNES Function norm 4.080637194736e+02 0 KSP Residual norm 8.136557176540e+00 1 KSP Residual norm 8.800137844173e-13 Line search: gnorm after quadratic fit 5.261656549654e+02 Line search: Cubic step no good, shrinking lambda, current gnorm 4.131114070934e+02 lambda=5.0000000000000003e-02 Line search: Cubically determined step, current gnorm 4.031614746044e+02 lambda=2.4674842039461482e-02 5 SNES Function norm 4.031614746044e+02 0 KSP Residual norm 7.609918907567e+00 1 KSP Residual norm 1.613159932655e-13 Line search: gnorm after quadratic fit 5.353908064984e+02 Line search: Cubic step no good, shrinking lambda, current gnorm 4.110480554132e+02 lambda=5.0000000000000003e-02 Line search: Cubically determined step, current gnorm 3.991168240716e+02 lambda=2.3079500036735322e-02 6 SNES Function norm 3.991168240716e+02 0 KSP Residual norm 3.800845472041e+00 1 KSP Residual norm 4.841682188278e-13 Line search: gnorm after quadratic fit 3.787886582952e+02 Line search: Quadratically determined step, lambda=1.0000000000000001e-01 7 SNES Function norm 3.787886582952e+02 0 KSP Residual norm 1.892621919219e+00 1 KSP Residual norm 3.576655371800e-12 Line search: gnorm after quadratic fit 3.440181918909e+02 Line search: Quadratically determined step, lambda=1.0000000000000001e-01 8 SNES Function norm 3.440181918909e+02 0 KSP Residual norm 3.559759789147e+00 1 KSP Residual norm 8.347521826622e-13 Line search: gnorm after quadratic fit 3.287993515195e+02 Line search: Quadratically determined step, lambda=1.0000000000000001e-01 9 SNES Function norm 3.287993515195e+02 0 KSP Residual norm 1.825073540507e+00 1 KSP Residual norm 8.352745008123e-14 Line search: Using full step: fnorm 3.287993515195e+02 gnorm 2.710650507416e+02 10 SNES Function norm 2.710650507416e+02 0 KSP Residual norm 7.568432945608e-01 1 KSP Residual norm 2.780715252274e-14 Line search: Using full step: fnorm 2.710650507416e+02 gnorm 1.513359047342e+02 11 SNES Function norm 1.513359047342e+02 0 KSP Residual norm 9.387460484575e+00 1 KSP Residual norm 7.091233040676e-13 Line search: gnorm after quadratic fit 3.998857979851e+02 Line search: Cubic step no good, shrinking lambda, current gnorm 2.060972049714e+02 lambda=5.0000000000000003e-02 Line search: Cubically determined step, current gnorm 1.512140169420e+02 lambda=5.4338709720680610e-03 12 SNES Function norm 1.512140169420e+02 0 KSP Residual norm 4.399424360499e+00 1 KSP Residual norm 1.614362118182e-13 Line search: gnorm after quadratic fit 1.913552832643e+02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.559719302467e+02 lambda=5.0000000000000003e-02 Line search: Cubically determined step, current gnorm 1.499985374733e+02 lambda=1.7102027220313589e-02 13 SNES Function norm 1.499985374733e+02 0 KSP Residual norm 3.740397849742e+00 1 KSP Residual norm 8.986775577006e-13 Line search: gnorm after quadratic fit 1.764118876632e+02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.522381536119e+02 lambda=4.8196830215713270e-02 Line search: Cubically determined step, current gnorm 1.486175880390e+02 lambda=1.8881300948189364e-02 14 SNES Function norm 1.486175880390e+02 0 KSP Residual norm 6.067973818528e+00 1 KSP Residual norm 4.527845229549e-13 Line search: gnorm after quadratic fit 2.514021299115e+02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.679972156573e+02 lambda=5.0000000000000003e-02 Line search: Cubically determined step, current gnorm 1.481015724304e+02 lambda=9.0116621678703428e-03 15 SNES Function norm 1.481015724304e+02 0 KSP Residual norm 6.108754994263e+00 1 KSP Residual norm 2.557635976440e-13 Line search: gnorm after quadratic fit 2.458081150104e+02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.681837029397e+02 lambda=5.0000000000000003e-02 Line search: Cubically determined step, current gnorm 1.476148340442e+02 lambda=7.9580911933571953e-03 16 SNES Function norm 1.476148340442e+02 0 KSP Residual norm 7.914946163932e+00 1 KSP Residual norm 1.512066885699e-13 Line search: gnorm after quadratic fit 3.458938604598e+02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.883018868359e+02 lambda=5.0000000000000003e-02 Line search: Cubically determined step, current gnorm 1.474286108114e+02 lambda=6.7262521208543979e-03 17 SNES Function norm 1.474286108114e+02 0 KSP Residual norm 5.285449532689e+00 1 KSP Residual norm 6.693733977456e-12 Line search: gnorm after quadratic fit 2.170263102661e+02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.607560548008e+02 lambda=5.0000000000000003e-02 Line search: Cubically determined step, current gnorm 1.467785507822e+02 lambda=9.9244383205188240e-03 18 SNES Function norm 1.467785507822e+02 0 KSP Residual norm 8.124903695635e+00 1 KSP Residual norm 2.322439601127e-11 Line search: gnorm after quadratic fit 3.589716592364e+02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.907315184877e+02 lambda=5.0000000000000003e-02 Line search: Cubically determined step, current gnorm 1.466341888638e+02 lambda=6.5538271222582893e-03 19 SNES Function norm 1.466341888638e+02 0 KSP Residual norm 5.253550718343e+00 1 KSP Residual norm 1.575657996883e-12 Line search: gnorm after quadratic fit 2.155795776725e+02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.598564001687e+02 lambda=5.0000000000000003e-02 Line search: Cubically determined step, current gnorm 1.459869404602e+02 lambda=9.9195822632931301e-03 20 SNES Function norm 1.459869404602e+02 0 KSP Residual norm 8.405987790193e+00 1 KSP Residual norm 2.046159481178e-13 Line search: gnorm after quadratic fit 3.767908298426e+02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.941885062002e+02 lambda=5.0000000000000003e-02 Line search: Cubically determined step, current gnorm 1.458995232755e+02 lambda=6.4359684554015136e-03 21 SNES Function norm 1.458995232755e+02 0 KSP Residual norm 5.036348246593e+00 1 KSP Residual norm 3.645081669075e-13 Line search: gnorm after quadratic fit 2.083222977519e+02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.575737508694e+02 lambda=5.0000000000000003e-02 Line search: Cubically determined step, current gnorm 1.452039802458e+02 lambda=1.0554092389542354e-02 22 SNES Function norm 1.452039802458e+02 0 KSP Residual norm 8.562292355998e+00 1 KSP Residual norm 3.256332645483e-13 Line search: gnorm after quadratic fit 3.869470823355e+02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.959483128249e+02 lambda=5.0000000000000003e-02 Line search: Cubically determined step, current gnorm 1.451523830598e+02 lambda=6.3780526507799607e-03 23 SNES Function norm 1.451523830598e+02 0 KSP Residual norm 4.919667503862e+00 1 KSP Residual norm 4.823931177115e-13 Line search: gnorm after quadratic fit 2.042891039525e+02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.560623102934e+02 lambda=5.0000000000000003e-02 Line search: Cubically determined step, current gnorm 1.444331916523e+02 lambda=1.0890355421223689e-02 24 SNES Function norm 1.444331916523e+02 0 KSP Residual norm 8.727282395369e+00 1 KSP Residual norm 7.090683582186e-13 Line search: gnorm after quadratic fit 3.977929422821e+02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.978556223200e+02 lambda=5.0000000000000003e-02 Line search: Cubically determined step, current gnorm 1.444215965394e+02 lambda=6.3477766966048947e-03 25 SNES Function norm 1.444215965394e+02 0 KSP Residual norm 4.759732971179e+00 1 KSP Residual norm 7.539889498211e-13 Line search: gnorm after quadratic fit 1.990589649135e+02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.542648241555e+02 lambda=5.0000000000000003e-02 Line search: Cubically determined step, current gnorm 1.436629416941e+02 lambda=1.1434720389464151e-02 26 SNES Function norm 1.436629416941e+02 0 KSP Residual norm 8.844861828477e+00 1 KSP Residual norm 4.372001279689e-13 Line search: gnorm after quadratic fit 4.055598972133e+02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.990820671396e+02 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.436827663113e+02 lambda=6.3302081701296859e-03 Line search: Cubically determined step, current gnorm 1.434397789472e+02 lambda=3.1285674619640730e-03 27 SNES Function norm 1.434397789472e+02 0 KSP Residual norm 2.168630760128e+01 1 KSP Residual norm 3.975838928402e-13 Line search: gnorm after quadratic fit 1.655681371309e+03 Line search: Cubic step no good, shrinking lambda, current gnorm 4.972331169594e+02 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.804118272840e+02 lambda=1.6710557456633125e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.435928635079e+02 lambda=1.6710557456633126e-03 Line search: Cubically determined step, current gnorm 1.434032742903e+02 lambda=5.1357350159978810e-04 28 SNES Function norm 1.434032742903e+02 0 KSP Residual norm 5.259508821923e+01 1 KSP Residual norm 1.358381204928e-11 Line search: gnorm after quadratic fit 1.908330224731e+04 Line search: Cubic step no good, shrinking lambda, current gnorm 3.431279702545e+03 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 8.060945045253e+02 lambda=2.5000000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 2.791318323447e+02 lambda=1.2124172979783788e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.491140019897e+02 lambda=2.6952165802905347e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.434246250245e+02 lambda=2.6952165802905350e-04 Line search: Cubically determined step, current gnorm 1.433970449422e+02 lambda=8.6980371578986910e-05 29 SNES Function norm 1.433970449422e+02 0 KSP Residual norm 1.326287161615e+02 1 KSP Residual norm 5.692176796134e-12 Line search: gnorm after quadratic fit 2.077891749832e+05 Line search: Cubic step no good, shrinking lambda, current gnorm 2.654187989332e+04 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 4.213029457851e+03 lambda=2.5000000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.001385334742e+03 lambda=1.2500000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 3.323976827250e+02 lambda=5.9607661619885998e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.489839529892e+02 lambda=1.0476257410701045e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.434396736634e+02 lambda=1.0476257410701046e-04 Line search: Cubically determined step, current gnorm 1.433960671821e+02 lambda=1.3664867646895530e-05 30 SNES Function norm 1.433960671821e+02 0 KSP Residual norm 3.320710360189e+02 1 KSP Residual norm 1.365660123102e-11 Line search: gnorm after quadratic fit 3.597335441013e+06 Line search: Cubic step no good, shrinking lambda, current gnorm 4.714766420450e+05 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 6.566809766217e+04 lambda=2.5000000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.038660363150e+04 lambda=1.2500000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 2.026997416957e+03 lambda=6.2500000000000003e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 5.382653551072e+02 lambda=3.1250000000000002e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 2.071747386385e+02 lambda=1.3384948046761360e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.439693866777e+02 lambda=1.3384948046761360e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 1.434000505249e+02 lambda=1.3384948046761361e-05 Line search: Cubically determined step, current gnorm 1.433959111179e+02 lambda=2.1771867000079373e-06 31 SNES Function norm 1.433959111179e+02 0 KSP Residual norm 8.385024273664e+02 1 KSP Residual norm 2.688330817732e-11 Line search: gnorm after quadratic fit 5.487352481970e+07 Line search: Cubic step no good, shrinking lambda, current gnorm 6.776642694838e+06 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 8.310551423141e+05 lambda=2.5000000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.023322644608e+05 lambda=1.2500000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.368662233379e+04 lambda=6.2500000000000003e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 2.472194884015e+03 lambda=3.1250000000000002e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 6.718801059897e+02 lambda=1.5625000000000001e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 2.274234972424e+02 lambda=6.3064412238487922e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 1.442194384053e+02 lambda=6.3064412238487925e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 1.434033578642e+02 lambda=6.3064412238487927e-06 Line search: Cubically determined step, current gnorm 1.433959042208e+02 lambda=6.3064412238487929e-07 32 SNES Function norm 1.433959042208e+02 0 KSP Residual norm 5.310191626867e+02 1 KSP Residual norm 2.270033897601e-10 Line search: gnorm after quadratic fit 1.447633783740e+07 Line search: Cubic step no good, shrinking lambda, current gnorm 1.859761774309e+06 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 2.472992503503e+05 lambda=2.5000000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 3.557594026810e+04 lambda=1.2500000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 5.969012939380e+03 lambda=6.2500000000000003e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.269212161982e+03 lambda=3.1250000000000002e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 3.859005100842e+02 lambda=1.5625000000000001e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.695095262046e+02 lambda=5.4509037994531233e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 1.436389958907e+02 lambda=5.4509037994531237e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 1.433976258223e+02 lambda=5.4509037994531242e-06 Line search: Cubically determined step, current gnorm 1.433958431980e+02 lambda=8.5124820362933632e-07 33 SNES Function norm 1.433958431980e+02 0 KSP Residual norm 1.341142541825e+03 1 KSP Residual norm 4.194815344365e-11 Line search: gnorm after quadratic fit 2.256410317099e+08 Line search: Cubic step no good, shrinking lambda, current gnorm 2.797696259877e+07 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 3.447237377751e+06 lambda=2.5000000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 4.221898175722e+05 lambda=1.2500000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 5.260244723327e+04 lambda=6.2500000000000003e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 7.539148524881e+03 lambda=3.1250000000000002e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.558034531173e+03 lambda=1.5625000000000001e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 4.788188892302e+02 lambda=7.8125000000000004e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 1.753621043454e+02 lambda=2.4427125599600652e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 1.437122397600e+02 lambda=2.4427125599600654e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 1.433986985128e+02 lambda=2.4427125599600655e-06 Line search: Cubically determined step, current gnorm 1.433958402293e+02 lambda=2.4427125599600656e-07 34 SNES Function norm 1.433958402293e+02 0 KSP Residual norm 8.620962950418e+02 1 KSP Residual norm 4.517777375659e-11 Line search: gnorm after quadratic fit 6.134442313460e+07 Line search: Cubic step no good, shrinking lambda, current gnorm 7.790495969255e+06 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.008365220843e+06 lambda=2.5000000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.364572513478e+05 lambda=1.2500000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 2.037891335918e+04 lambda=6.2500000000000003e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 3.640571521199e+03 lambda=3.1250000000000002e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 8.472549649319e+02 lambda=1.5625000000000001e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 2.906041216274e+02 lambda=7.6348458761785112e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 1.504925859329e+02 lambda=1.7740973415567094e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 1.434632637071e+02 lambda=1.7740973415567094e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 1.433962847027e+02 lambda=1.7740973415567095e-06 Line search: Cubically determined step, current gnorm 1.433958170795e+02 lambda=3.2293255704969003e-07 35 SNES Function norm 1.433958170795e+02 0 KSP Residual norm 2.177497039945e+03 1 KSP Residual norm 8.546235181505e-11 Line search: gnorm after quadratic fit 9.689178330938e+08 Line search: Cubic step no good, shrinking lambda, current gnorm 1.204850731541e+08 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.491460480376e+07 lambda=2.5000000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.833699292784e+06 lambda=1.2500000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 2.246639021599e+05 lambda=6.2500000000000003e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 2.860166571872e+04 lambda=3.1250000000000002e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 4.484329051490e+03 lambda=1.5625000000000001e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.050411687443e+03 lambda=7.8125000000000004e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 3.488366972009e+02 lambda=3.7767265396089055e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 1.508326035050e+02 lambda=7.2725649346261757e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 1.434696063559e+02 lambda=7.2725649346261764e-06 Line search: Cubic step no good, shrinking lambda, current gnorm 1.433964618996e+02 lambda=7.2725649346261768e-07 Line search: Cubically determined step, current gnorm 1.433958141405e+02 lambda=7.2725649346261771e-08 36 SNES Function norm 1.433958141405e+02 0 KSP Residual norm 2.164813477994e+03 1 KSP Residual norm 1.148881458292e-10 Line search: gnorm after quadratic fit 9.626940870744e+08 Line search: Cubic step no good, shrinking lambda, current gnorm 1.210459267934e+08 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.531855101756e+07 lambda=2.5000000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.966826097072e+06 lambda=1.2500000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 2.611808255272e+05 lambda=6.2500000000000003e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 3.746062783262e+04 lambda=3.1250000000000002e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 6.252259871244e+03 lambda=1.5625000000000001e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.319447372021e+03 lambda=7.8125000000000004e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 3.963055448218e+02 lambda=3.9062500000000002e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 1.719034797105e+02 lambda=1.3935000445038475e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 1.436664111092e+02 lambda=1.3935000445038476e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 1.433983336239e+02 lambda=1.3935000445038476e-06 Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958213497e+02 lambda=1.3935000445038476e-07 Line search: Cubically determined step, current gnorm 1.433958104705e+02 lambda=5.1202466521517630e-08 37 SNES Function norm 1.433958104705e+02 0 KSP Residual norm 5.470482746849e+03 1 KSP Residual norm 2.077456833170e-10 Line search: gnorm after quadratic fit 1.541335606193e+10 Line search: Cubic step no good, shrinking lambda, current gnorm 1.922526157954e+09 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 2.393079394383e+08 lambda=2.5000000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 2.967573549050e+07 lambda=1.2500000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 3.657319925168e+06 lambda=6.2500000000000003e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 4.479516204895e+05 lambda=3.1250000000000002e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 5.573399122917e+04 lambda=1.5625000000000001e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 7.931177424479e+03 lambda=7.8125000000000004e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 1.619710606187e+03 lambda=3.9062500000000002e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 4.924551713717e+02 lambda=1.9531250000000001e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 1.786095404459e+02 lambda=6.2808469554243522e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 1.437467476469e+02 lambda=6.2808469554243527e-06 Line search: Cubic step no good, shrinking lambda, current gnorm 1.433992463439e+02 lambda=6.2808469554243527e-07 Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958367271e+02 lambda=6.2808469554243525e-08 Line search: Cubically determined step, current gnorm 1.433958098948e+02 lambda=8.0208105170108588e-09 38 SNES Function norm 1.433958098948e+02 0 KSP Residual norm 1.380568582849e+04 1 KSP Residual norm 3.830866223513e-10 Line search: gnorm after quadratic fit 2.484973518314e+11 Line search: Cubic step no good, shrinking lambda, current gnorm 3.108953896984e+10 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 3.893104137528e+09 lambda=2.5000000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 4.884003910853e+08 lambda=1.2500000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 6.150765563542e+07 lambda=6.2500000000000003e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 7.811161146103e+06 lambda=3.1250000000000002e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.011017986781e+06 lambda=1.5625000000000001e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.368084343451e+05 lambda=7.8125000000000004e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 2.042876665700e+04 lambda=3.9062500000000002e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 3.648735196752e+03 lambda=1.9531250000000001e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 8.489051252413e+02 lambda=9.7656250000000005e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 2.910677756717e+02 lambda=4.7728537787817724e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 1.505452645186e+02 lambda=1.1099980464343249e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 1.434658984864e+02 lambda=1.1099980464343249e-06 Line search: Cubic step no good, shrinking lambda, current gnorm 1.433964956476e+02 lambda=1.1099980464343249e-07 Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958153212e+02 lambda=1.1099980464343250e-08 Line search: Cubically determined step, current gnorm 1.433958098048e+02 lambda=1.2587012037197021e-09 39 SNES Function norm 1.433958098048e+02 0 KSP Residual norm 3.492284741552e+04 1 KSP Residual norm 2.459788921244e-09 Line search: gnorm after quadratic fit 4.017424324975e+12 Line search: Cubic step no good, shrinking lambda, current gnorm 5.020053801097e+11 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 6.270768402853e+10 lambda=2.5000000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 7.827801904036e+09 lambda=1.2500000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 9.758550488105e+08 lambda=6.2500000000000003e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.213492627852e+08 lambda=3.1250000000000002e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.502191365805e+07 lambda=1.5625000000000001e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.846947104704e+06 lambda=7.8125000000000004e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 2.262850216093e+05 lambda=3.9062500000000002e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 2.879926646684e+04 lambda=1.9531250000000001e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 4.510203332079e+03 lambda=9.7656250000000005e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 1.055028679619e+03 lambda=4.8828125000000003e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 3.503903269554e+02 lambda=2.3633949212111800e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 1.510245991472e+02 lambda=4.5897967908360529e-06 Line search: Cubic step no good, shrinking lambda, current gnorm 1.434724062782e+02 lambda=4.5897967908360533e-07 Line search: Cubic step no good, shrinking lambda, current gnorm 1.433965706606e+02 lambda=4.5897967908360533e-08 Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958168196e+02 lambda=4.5897967908360538e-09 Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958098155e+02 lambda=4.5897967908360540e-10 Line search: Cubically determined step, current gnorm 1.433958097906e+02 lambda=1.9745369723997599e-10 40 SNES Function norm 1.433958097906e+02 0 KSP Residual norm 8.722495521587e+04 1 KSP Residual norm 3.742695919275e-09 Line search: gnorm after quadratic fit 6.262538457180e+13 Line search: Cubic step no good, shrinking lambda, current gnorm 7.829256308992e+12 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 9.789282877890e+11 lambda=2.5000000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.224340679566e+11 lambda=1.2500000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.532137613500e+10 lambda=6.2500000000000003e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.919506047737e+09 lambda=3.1250000000000002e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 2.410488718338e+08 lambda=1.5625000000000001e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 3.042211373104e+07 lambda=7.8125000000000004e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 3.881986305609e+06 lambda=3.9062500000000002e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 5.080857001861e+05 lambda=1.9531250000000001e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 7.054449734307e+04 lambda=9.7656250000000005e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 1.109051581397e+04 lambda=4.8828125000000003e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 2.144985497099e+03 lambda=2.4414062500000001e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 5.617627947761e+02 lambda=1.2207031250000001e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 2.132828960986e+02 lambda=5.3137869181552773e-06 Line search: Cubic step no good, shrinking lambda, current gnorm 1.440403409760e+02 lambda=5.3137869181552777e-07 Line search: Cubic step no good, shrinking lambda, current gnorm 1.434022226216e+02 lambda=5.3137869181552781e-08 Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958732177e+02 lambda=5.3137869181552781e-09 Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958103569e+02 lambda=5.3137869181552779e-10 Line search: Cubically determined step, current gnorm 1.433958097894e+02 lambda=5.3137869181552781e-11 41 SNES Function norm 1.433958097894e+02 0 KSP Residual norm 6.453169081212e+04 1 KSP Residual norm 2.762540688686e-09 Line search: gnorm after quadratic fit 2.535166112592e+13 Line search: Cubic step no good, shrinking lambda, current gnorm 3.168366990040e+12 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 3.958985371462e+11 lambda=2.5000000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 4.945064622488e+10 lambda=1.2500000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 6.172244865713e+09 lambda=6.2500000000000003e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 7.693002384290e+08 lambda=3.1250000000000002e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 9.562568994785e+07 lambda=1.5625000000000001e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.182957296890e+07 lambda=7.8125000000000004e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 1.453260254263e+06 lambda=3.9062500000000002e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 1.781984147743e+05 lambda=1.9531250000000001e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 2.294934468515e+04 lambda=9.7656250000000005e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 3.740461720782e+03 lambda=4.8828125000000003e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 9.162621855154e+02 lambda=2.4414062500000001e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 3.042417294890e+02 lambda=1.1290474210136388e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 1.458920680477e+02 lambda=1.4201366604660443e-06 Line search: Cubic step no good, shrinking lambda, current gnorm 1.434208620254e+02 lambda=1.4201366604660444e-07 Line search: Cubic step no good, shrinking lambda, current gnorm 1.433960586269e+02 lambda=1.4201366604660445e-08 Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958120934e+02 lambda=1.4201366604660445e-09 Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958097940e+02 lambda=1.4201366604660446e-10 Line search: Cubically determined step, current gnorm 1.433958097852e+02 lambda=5.7981795207229486e-11 42 SNES Function norm 1.433958097852e+02 0 KSP Residual norm 1.596625793747e+05 1 KSP Residual norm 6.465899717071e-09 Line search: gnorm after quadratic fit 3.840699863976e+14 Line search: Cubic step no good, shrinking lambda, current gnorm 4.801237514773e+13 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 6.002454410823e+12 lambda=2.5000000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 7.505340831651e+11 lambda=1.2500000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 9.387378188418e+10 lambda=6.2500000000000003e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.174857842415e+10 lambda=3.1250000000000002e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.472211181784e+09 lambda=1.5625000000000001e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.849608933788e+08 lambda=7.8125000000000004e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 2.336592011613e+07 lambda=3.9062500000000002e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 2.988079805895e+06 lambda=1.9531250000000001e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 3.930858080425e+05 lambda=9.7656250000000005e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 5.521190722497e+04 lambda=4.8828125000000003e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 8.872153015323e+03 lambda=2.4414062500000001e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 1.772337662956e+03 lambda=1.2207031250000001e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 4.879470852054e+02 lambda=6.1035156250000003e-06 Line search: Cubic step no good, shrinking lambda, current gnorm 1.942774855488e+02 lambda=2.4957912736226801e-06 Line search: Cubic step no good, shrinking lambda, current gnorm 1.438719078958e+02 lambda=2.4957912736226800e-07 Line search: Cubic step no good, shrinking lambda, current gnorm 1.434005516391e+02 lambda=2.4957912736226800e-08 Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958568732e+02 lambda=2.4957912736226803e-09 Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958102244e+02 lambda=2.4957912736226804e-10 Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958097865e+02 lambda=2.4957912736226805e-11 Line search: Cubically determined step, current gnorm 1.433958097846e+02 lambda=9.2900433293108317e-12 43 SNES Function norm 1.433958097846e+02 0 KSP Residual norm 4.230869747157e+05 1 KSP Residual norm 2.238707423027e-08 Line search: gnorm after quadratic fit 7.145700515048e+15 Line search: Cubic step no good, shrinking lambda, current gnorm 8.931871281700e+14 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.116420341041e+14 lambda=2.5000000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.395366610168e+13 lambda=1.2500000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.743811756566e+12 lambda=6.2500000000000003e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 2.178776103292e+11 lambda=3.1250000000000002e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 2.721012032848e+10 lambda=1.5625000000000001e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 3.395186924428e+09 lambda=7.8125000000000004e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 4.229125978585e+08 lambda=3.9062500000000002e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 5.250971135953e+07 lambda=1.9531250000000001e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 6.483856203094e+06 lambda=9.7656250000000005e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 7.950671355228e+05 lambda=4.8828125000000003e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 9.795408218555e+04 lambda=2.4414062500000001e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 1.315025696280e+04 lambda=1.2207031250000001e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 2.395961070555e+03 lambda=6.1035156250000003e-06 Line search: Cubic step no good, shrinking lambda, current gnorm 6.565070307576e+02 lambda=3.0517578125000002e-06 Line search: Cubic step no good, shrinking lambda, current gnorm 2.228949713871e+02 lambda=1.2154989071946628e-06 Line search: Cubic step no good, shrinking lambda, current gnorm 1.441831998014e+02 lambda=1.2154989071946629e-07 Line search: Cubic step no good, shrinking lambda, current gnorm 1.434037055996e+02 lambda=1.2154989071946630e-08 Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958886074e+02 lambda=1.2154989071946630e-09 Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958105564e+02 lambda=1.2154989071946630e-10 Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958097907e+02 lambda=1.2154989071946631e-11 Line search: Cubically determined step, current gnorm 1.433958097845e+02 lambda=1.3559489351735629e-12 44 SNES Function norm 1.433958097845e+02 0 KSP Residual norm 1.017589039922e+06 1 KSP Residual norm 5.483283808994e-08 Line search: gnorm after quadratic fit 9.942386816509e+16 Line search: Cubic step no good, shrinking lambda, current gnorm 1.242813073279e+16 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.553553149772e+15 lambda=2.5000000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.942033483320e+14 lambda=1.2500000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 2.427772097758e+13 lambda=6.2500000000000003e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 3.035291372732e+12 lambda=3.1250000000000002e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 3.795558047824e+11 lambda=1.5625000000000001e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 4.748073147307e+10 lambda=7.8125000000000004e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 5.944235240368e+09 lambda=3.9062500000000002e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 7.453550734860e+08 lambda=1.9531250000000001e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 9.377045707707e+07 lambda=9.7656250000000005e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 1.188119937132e+07 lambda=4.8828125000000003e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 1.529730353136e+06 lambda=2.4414062500000001e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 2.044646611329e+05 lambda=1.2207031250000001e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 2.974477616118e+04 lambda=6.1035156250000003e-06 Line search: Cubic step no good, shrinking lambda, current gnorm 5.087923877078e+03 lambda=3.0517578125000002e-06 Line search: Cubic step no good, shrinking lambda, current gnorm 1.112257173311e+03 lambda=1.5258789062500001e-06 Line search: Cubic step no good, shrinking lambda, current gnorm 3.536190077033e+02 lambda=7.6293945312500004e-07 Line search: Cubic step no good, shrinking lambda, current gnorm 1.622567424729e+02 lambda=2.4244966960965791e-07 Line search: Cubic step no good, shrinking lambda, current gnorm 1.435780438142e+02 lambda=2.4244966960965793e-08 Line search: Cubic step no good, shrinking lambda, current gnorm 1.433976282603e+02 lambda=2.4244966960965796e-09 Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958279382e+02 lambda=2.4244966960965797e-10 Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958099632e+02 lambda=2.4244966960965799e-11 Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958097860e+02 lambda=2.4244966960965801e-12 Line search: Cubically determined step, current gnorm 1.433958097845e+02 lambda=2.4244966960965801e-13 45 SNES Function norm 1.433958097845e+02 0 KSP Residual norm 2.206687220910e+06 1 KSP Residual norm 4.897651438902e-08 Line search: gnorm after quadratic fit 1.013883843512e+18 Line search: Cubic step no good, shrinking lambda, current gnorm 1.267347883019e+17 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.584167551460e+16 lambda=2.5000000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.980166189110e+15 lambda=1.2500000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 2.475099638694e+14 lambda=6.2500000000000003e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 3.093604443378e+13 lambda=3.1250000000000002e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 3.866330988164e+12 lambda=1.5625000000000001e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 4.831230804145e+11 lambda=7.8125000000000004e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 6.034848618023e+10 lambda=3.9062500000000002e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 7.533173457427e+09 lambda=1.9531250000000001e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 9.390937545910e+08 lambda=9.7656250000000005e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 1.167706366282e+08 lambda=4.8828125000000003e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 1.445357932595e+07 lambda=2.4414062500000001e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 1.776833600920e+06 lambda=1.2207031250000001e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 2.177171496134e+05 lambda=6.1035156250000003e-06 Line search: Cubic step no good, shrinking lambda, current gnorm 2.775750596740e+04 lambda=3.0517578125000002e-06 Line search: Cubic step no good, shrinking lambda, current gnorm 4.374283858049e+03 lambda=1.5258789062500001e-06 Line search: Cubic step no good, shrinking lambda, current gnorm 1.030949543491e+03 lambda=7.6293945312500004e-07 Line search: Cubic step no good, shrinking lambda, current gnorm 3.423064811256e+02 lambda=3.6673216108643130e-07 Line search: Cubic step no good, shrinking lambda, current gnorm 1.499924205417e+02 lambda=6.7541706529544844e-08 Line search: Cubic step no good, shrinking lambda, current gnorm 1.434620968378e+02 lambda=6.7541706529544851e-09 Line search: Cubic step no good, shrinking lambda, current gnorm 1.433964732224e+02 lambda=6.7541706529544853e-10 Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958164087e+02 lambda=6.7541706529544856e-11 Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958098496e+02 lambda=6.7541706529544860e-12 Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958097850e+02 lambda=6.7541706529544869e-13 Line search: unable to find good step length! After 24 tries Line search: fnorm=1.4339580978447020e+02, gnorm=1.4339580978501337e+02, ynorm=2.2066872446260620e+06, minlambda=9.9999999999999998e-13, lambda=6.7541706529544869e-13, initial slope=-2.0562359199040133e+04 0 SNES Function norm 7.494832241120e+03 0 KSP Residual norm 2.096735360816e+01 1 KSP Residual norm 1.310027756820e-12 Line search: gnorm after quadratic fit 6.728375857515e+03 Line search: Quadratically determined step, lambda=1.0000000000000001e-01 1 SNES Function norm 6.728375857515e+03 0 KSP Residual norm 2.051806116405e+01 1 KSP Residual norm 4.624620138831e-13 Line search: gnorm after quadratic fit 6.028616261650e+03 Line search: Quadratically determined step, lambda=1.0000000000000001e-01 2 SNES Function norm 6.028616261650e+03 0 KSP Residual norm 2.416503160016e+01 1 KSP Residual norm 8.456041680630e-13 Line search: gnorm after quadratic fit 5.407473517447e+03 Line search: Quadratically determined step, lambda=1.0000000000000001e-01 3 SNES Function norm 5.407473517447e+03 0 KSP Residual norm 1.429873750399e+01 1 KSP Residual norm 2.956316145819e-13 Line search: Using full step: fnorm 5.407473517447e+03 gnorm 1.894530516076e+03 4 SNES Function norm 1.894530516076e+03 0 KSP Residual norm 2.898580554597e+00 1 KSP Residual norm 6.622560162623e-14 Line search: Using full step: fnorm 1.894530516076e+03 gnorm 1.794029421846e+03 5 SNES Function norm 1.794029421846e+03 0 KSP Residual norm 1.749678611959e+01 1 KSP Residual norm 8.138905825078e-12 Line search: gnorm after quadratic fit 1.767361408940e+03 Line search: Quadratically determined step, lambda=1.0000000000000001e-01 6 SNES Function norm 1.767361408940e+03 0 KSP Residual norm 1.094404109423e+02 1 KSP Residual norm 7.696691527700e-12 Line search: gnorm after quadratic fit 3.545750923895e+04 Line search: Cubic step no good, shrinking lambda, current gnorm 6.153479540314e+03 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 2.205683629874e+03 lambda=2.5000000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.802976525485e+03 lambda=1.2441094586006883e-02 Line search: Cubically determined step, current gnorm 1.765063299263e+03 lambda=4.9240328094708914e-03 7 SNES Function norm 1.765063299263e+03 0 KSP Residual norm 1.778095975189e+01 1 KSP Residual norm 2.814661813934e-12 Line search: gnorm after quadratic fit 2.620761680117e+03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.793045753271e+03 lambda=5.0000000000000003e-02 Line search: Cubically determined step, current gnorm 1.740299227935e+03 lambda=2.5000000000000001e-02 8 SNES Function norm 1.740299227935e+03 0 KSP Residual norm 3.284236894535e+02 1 KSP Residual norm 5.172103783952e-10 Line search: gnorm after quadratic fit 2.857820523902e+05 Line search: Cubic step no good, shrinking lambda, current gnorm 4.063993491139e+04 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 7.588139591650e+03 lambda=2.5000000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 2.491163684413e+03 lambda=1.2500000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.802614760566e+03 lambda=5.7977212395253904e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.741444490992e+03 lambda=1.8448315876950813e-03 Line search: Cubically determined step, current gnorm 1.739663656043e+03 lambda=7.7468345598227730e-04 9 SNES Function norm 1.739663656043e+03 0 KSP Residual norm 4.581839103558e+02 1 KSP Residual norm 2.627035885943e-11 Line search: gnorm after quadratic fit 8.199478499066e+05 Line search: Cubic step no good, shrinking lambda, current gnorm 1.127270076812e+05 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.816774161281e+04 lambda=2.5000000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 4.053723877333e+03 lambda=1.2500000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.971814513392e+03 lambda=6.2500000000000003e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.755066208174e+03 lambda=2.7232010924558834e-03 Line search: Cubically determined step, current gnorm 1.739559834479e+03 lambda=8.1458417855297680e-04 10 SNES Function norm 1.739559834479e+03 0 KSP Residual norm 1.463056810139e+02 1 KSP Residual norm 5.383584598825e-12 Line search: gnorm after quadratic fit 2.885699620595e+04 Line search: Cubic step no good, shrinking lambda, current gnorm 5.847717401708e+03 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 2.244464170034e+03 lambda=2.5000000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.769157604338e+03 lambda=1.0857209099577540e-02 Line search: Cubically determined step, current gnorm 1.737356225452e+03 lambda=4.0312937622950231e-03 11 SNES Function norm 1.737356225452e+03 0 KSP Residual norm 1.564105677925e+02 1 KSP Residual norm 6.671164745832e-11 Line search: gnorm after quadratic fit 3.815800291873e+04 Line search: Cubic step no good, shrinking lambda, current gnorm 7.197027796134e+03 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 2.373151605545e+03 lambda=2.5000000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.783976520867e+03 lambda=1.2093374970461970e-02 Line search: Cubically determined step, current gnorm 1.735737929915e+03 lambda=4.9529698477569920e-03 12 SNES Function norm 1.735737929915e+03 0 KSP Residual norm 5.030757139645e+01 1 KSP Residual norm 1.157542730692e-12 Line search: gnorm after quadratic fit 3.004544441458e+03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.850403239750e+03 lambda=5.0000000000000003e-02 Line search: Cubically determined step, current gnorm 1.722893188305e+03 lambda=2.0881992439921702e-02 13 SNES Function norm 1.722893188305e+03 0 KSP Residual norm 7.123428853845e+01 1 KSP Residual norm 8.671726774894e-12 Line search: gnorm after quadratic fit 4.361041499279e+03 Line search: Cubic step no good, shrinking lambda, current gnorm 2.032697222107e+03 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.726212330814e+03 lambda=1.9909470348267504e-02 Line search: Cubically determined step, current gnorm 1.714127356920e+03 lambda=9.9547351741337518e-03 14 SNES Function norm 1.714127356920e+03 0 KSP Residual norm 8.304557447257e+00 1 KSP Residual norm 6.268295862688e-13 Line search: gnorm after quadratic fit 1.558163002487e+03 Line search: Quadratically determined step, lambda=1.0000000000000001e-01 15 SNES Function norm 1.558163002487e+03 0 KSP Residual norm 2.820803287164e+00 1 KSP Residual norm 5.477413853752e-13 Line search: gnorm after quadratic fit 1.065673478530e+03 Line search: Quadratically determined step, lambda=3.8943438938591052e-01 16 SNES Function norm 1.065673478530e+03 0 KSP Residual norm 2.296739120664e+00 1 KSP Residual norm 6.273731899885e-14 Line search: gnorm after quadratic fit 8.964342150621e+02 Line search: Quadratically determined step, lambda=1.8740736900935545e-01 17 SNES Function norm 8.964342150621e+02 0 KSP Residual norm 5.567568505830e+00 1 KSP Residual norm 8.649083600764e-12 Line search: gnorm after quadratic fit 8.322514858992e+02 Line search: Quadratically determined step, lambda=1.0000000000000001e-01 18 SNES Function norm 8.322514858992e+02 0 KSP Residual norm 1.164393577210e+00 1 KSP Residual norm 2.019248309015e-14 Line search: Using full step: fnorm 8.322514858992e+02 gnorm 3.179750274746e+02 19 SNES Function norm 3.179750274746e+02 0 KSP Residual norm 5.339294310641e+00 1 KSP Residual norm 2.070321587238e-13 Line search: gnorm after quadratic fit 3.433012316833e+02 Line search: Cubically determined step, current gnorm 3.140305403821e+02 lambda=5.0000000000000003e-02 20 SNES Function norm 3.140305403821e+02 0 KSP Residual norm 1.177016565578e+01 1 KSP Residual norm 2.413027540446e-13 Line search: gnorm after quadratic fit 7.377851778409e+02 Line search: Cubic step no good, shrinking lambda, current gnorm 3.896721016582e+02 lambda=5.0000000000000003e-02 Line search: Cubically determined step, current gnorm 3.136619309181e+02 lambda=9.7219892278716195e-03 21 SNES Function norm 3.136619309181e+02 0 KSP Residual norm 3.973565083977e+00 1 KSP Residual norm 9.726786674410e-14 Line search: gnorm after quadratic fit 3.098277326090e+02 Line search: Quadratically determined step, lambda=1.0000000000000001e-01 22 SNES Function norm 3.098277326090e+02 0 KSP Residual norm 9.389290683519e+00 1 KSP Residual norm 1.651497163724e-13 Line search: gnorm after quadratic fit 6.887970540455e+02 Line search: Cubic step no good, shrinking lambda, current gnorm 3.588146381477e+02 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 3.099274823603e+02 lambda=1.6890426151283184e-02 Line search: Cubically determined step, current gnorm 3.084890760827e+02 lambda=8.4452130756415920e-03 23 SNES Function norm 3.084890760827e+02 0 KSP Residual norm 2.381130479641e+00 1 KSP Residual norm 4.694489283156e-14 Line search: gnorm after quadratic fit 2.872151876535e+02 Line search: Quadratically determined step, lambda=1.0000000000000001e-01 24 SNES Function norm 2.872151876535e+02 0 KSP Residual norm 2.405498502269e+00 1 KSP Residual norm 3.316846070538e-13 Line search: gnorm after quadratic fit 2.686789761232e+02 Line search: Quadratically determined step, lambda=1.0000000000000001e-01 25 SNES Function norm 2.686789761232e+02 0 KSP Residual norm 1.728772970554e+00 1 KSP Residual norm 4.132974383339e-14 Line search: gnorm after quadratic fit 2.365009918229e+02 Line search: Quadratically determined step, lambda=1.7273357529379074e-01 26 SNES Function norm 2.365009918229e+02 0 KSP Residual norm 4.413764759374e+00 1 KSP Residual norm 5.210690816917e-14 Line search: gnorm after quadratic fit 2.756730968257e+02 Line search: Cubic step no good, shrinking lambda, current gnorm 2.372321757171e+02 lambda=5.0000000000000003e-02 Line search: Cubically determined step, current gnorm 2.335020811250e+02 lambda=2.5000000000000001e-02 27 SNES Function norm 2.335020811250e+02 0 KSP Residual norm 1.606246507553e+00 1 KSP Residual norm 3.564847846678e-14 Line search: gnorm after quadratic fit 2.078263630653e+02 Line search: Quadratically determined step, lambda=1.5913860995949433e-01 28 SNES Function norm 2.078263630653e+02 0 KSP Residual norm 3.700632954873e+00 1 KSP Residual norm 5.113863400264e-13 Line search: gnorm after quadratic fit 2.142503514807e+02 Line search: Cubically determined step, current gnorm 2.021095009118e+02 lambda=5.0000000000000003e-02 29 SNES Function norm 2.021095009118e+02 0 KSP Residual norm 3.056449560135e+00 1 KSP Residual norm 3.207987681334e-14 Line search: gnorm after quadratic fit 2.064252530802e+02 Line search: Cubically determined step, current gnorm 1.978069081639e+02 lambda=5.0000000000000003e-02 30 SNES Function norm 1.978069081639e+02 0 KSP Residual norm 2.024695620703e+00 1 KSP Residual norm 5.460360737995e-14 Line search: gnorm after quadratic fit 1.839556530796e+02 Line search: Quadratically determined step, lambda=1.0000000000000001e-01 31 SNES Function norm 1.839556530796e+02 0 KSP Residual norm 1.610676619931e+01 1 KSP Residual norm 6.703552136307e-13 Line search: gnorm after quadratic fit 7.186735314913e+02 Line search: Cubic step no good, shrinking lambda, current gnorm 2.905672430097e+02 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.856766286600e+02 lambda=1.0830798014298563e-02 Line search: Cubically determined step, current gnorm 1.836818937131e+02 lambda=3.3207362501459785e-03 32 SNES Function norm 1.836818937131e+02 0 KSP Residual norm 7.471722173131e+01 1 KSP Residual norm 2.671534648829e-12 Line search: gnorm after quadratic fit 9.613379909411e+04 Line search: Cubic step no good, shrinking lambda, current gnorm 1.509491298762e+04 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 2.808861367705e+03 lambda=2.5000000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 6.767283758299e+02 lambda=1.2500000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 2.665421328348e+02 lambda=6.0369453941238101e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.869726717041e+02 lambda=1.4394327006264963e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.836897704575e+02 lambda=1.4394327006264963e-04 Line search: Cubically determined step, current gnorm 1.836767951408e+02 lambda=5.5567420418543164e-05 33 SNES Function norm 1.836767951408e+02 0 KSP Residual norm 2.702367712138e+01 1 KSP Residual norm 2.731656687850e-12 Line search: gnorm after quadratic fit 3.331563146098e+03 Line search: Cubic step no good, shrinking lambda, current gnorm 8.723694790688e+02 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 2.941243220944e+02 lambda=2.1443568774664485e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.847231733910e+02 lambda=2.7571330376860012e-03 Line search: Cubically determined step, current gnorm 1.836356729409e+02 lambda=4.7841280418270480e-04 34 SNES Function norm 1.836356729409e+02 0 KSP Residual norm 1.228333177997e+01 1 KSP Residual norm 2.681127387880e-13 Line search: gnorm after quadratic fit 6.936329223475e+02 Line search: Cubic step no good, shrinking lambda, current gnorm 2.749327218775e+02 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.871557327742e+02 lambda=1.4160505301999991e-02 Line search: Cubically determined step, current gnorm 1.833523080682e+02 lambda=3.5196326548579192e-03 35 SNES Function norm 1.833523080682e+02 0 KSP Residual norm 3.531886257396e+02 1 KSP Residual norm 2.364634092895e-11 Line search: gnorm after quadratic fit 3.994783047929e+06 Line search: Cubic step no good, shrinking lambda, current gnorm 4.753715960726e+05 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 5.516669898185e+04 lambda=2.5000000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 6.918985942348e+03 lambda=1.2500000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.363599250418e+03 lambda=6.2500000000000003e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 4.344906818752e+02 lambda=3.1250000000000002e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.991088183980e+02 lambda=1.0108094710462592e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.834621681844e+02 lambda=1.0108094710462593e-04 Line search: Cubically determined step, current gnorm 1.833517377324e+02 lambda=1.0108094710462594e-05 36 SNES Function norm 1.833517377324e+02 0 KSP Residual norm 9.005833507118e+01 1 KSP Residual norm 6.116387880629e-12 Line search: gnorm after quadratic fit 8.899847103226e+04 Line search: Cubic step no good, shrinking lambda, current gnorm 1.388111536526e+04 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 2.532652074749e+03 lambda=2.5000000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 5.864912734009e+02 lambda=1.2500000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 2.421068789960e+02 lambda=6.2500000000000003e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.873498120960e+02 lambda=2.1924025345283278e-03 Line search: Cubically determined step, current gnorm 1.833506987706e+02 lambda=2.1924025345283280e-04 37 SNES Function norm 1.833506987706e+02 0 KSP Residual norm 1.548426525207e+01 1 KSP Residual norm 1.038038773942e-12 Line search: gnorm after quadratic fit 6.702848665441e+02 Line search: Cubic step no good, shrinking lambda, current gnorm 2.789880616078e+02 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.846521504351e+02 lambda=1.0567302644323170e-02 Line search: Cubically determined step, current gnorm 1.830548481815e+02 lambda=3.5274490352771972e-03 38 SNES Function norm 1.830548481815e+02 0 KSP Residual norm 1.523095478807e+01 1 KSP Residual norm 1.963823596119e-12 Line search: gnorm after quadratic fit 9.255727478491e+02 Line search: Cubic step no good, shrinking lambda, current gnorm 3.496757253461e+02 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.863126241242e+02 lambda=9.3143291632966311e-03 Line search: Cubically determined step, current gnorm 1.829091761403e+02 lambda=1.8107234819462800e-03 39 SNES Function norm 1.829091761403e+02 0 KSP Residual norm 1.311320726934e+01 1 KSP Residual norm 9.084170520902e-13 Line search: gnorm after quadratic fit 7.488610069188e+02 Line search: Cubic step no good, shrinking lambda, current gnorm 2.691148243365e+02 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.885558228772e+02 lambda=1.9439894235886539e-02 Line search: Cubically determined step, current gnorm 1.825540619134e+02 lambda=5.4967824488704169e-03 40 SNES Function norm 1.825540619134e+02 0 KSP Residual norm 1.218635557505e+01 1 KSP Residual norm 7.760485728617e-13 Line search: gnorm after quadratic fit 6.636453826807e+02 Line search: Cubic step no good, shrinking lambda, current gnorm 2.880828006022e+02 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.830493790584e+02 lambda=6.6234802648049863e-03 Line search: Cubically determined step, current gnorm 1.823397545268e+02 lambda=2.4308217464828865e-03 41 SNES Function norm 1.823397545268e+02 0 KSP Residual norm 9.456543593865e+00 1 KSP Residual norm 7.046593270309e-13 Line search: gnorm after quadratic fit 3.369769163110e+02 Line search: Cubic step no good, shrinking lambda, current gnorm 2.105230957789e+02 lambda=5.0000000000000003e-02 Line search: Cubically determined step, current gnorm 1.817897533119e+02 lambda=9.1612481372917148e-03 42 SNES Function norm 1.817897533119e+02 0 KSP Residual norm 7.290035145805e+00 1 KSP Residual norm 3.198962158141e-12 Line search: gnorm after quadratic fit 2.858311567415e+02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.965004842981e+02 lambda=5.0000000000000003e-02 Line search: Cubically determined step, current gnorm 1.808845577764e+02 lambda=1.3826421990147811e-02 43 SNES Function norm 1.808845577764e+02 0 KSP Residual norm 7.256785036157e+00 1 KSP Residual norm 9.243179217625e-14 Line search: gnorm after quadratic fit 2.534388176390e+02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.916726818893e+02 lambda=5.0000000000000003e-02 Line search: Cubically determined step, current gnorm 1.797953125543e+02 lambda=1.3677747819164022e-02 44 SNES Function norm 1.797953125543e+02 0 KSP Residual norm 1.716201096352e+01 1 KSP Residual norm 2.701418800808e-13 Line search: gnorm after quadratic fit 1.331064301474e+03 Line search: Cubic step no good, shrinking lambda, current gnorm 4.461842246267e+02 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.920668830294e+02 lambda=1.2856504859057132e-02 Line search: Cubically determined step, current gnorm 1.797121460957e+02 lambda=1.4396611381500967e-03 45 SNES Function norm 1.797121460957e+02 0 KSP Residual norm 6.613432967985e+00 1 KSP Residual norm 1.357752977076e-13 Line search: gnorm after quadratic fit 2.721288927858e+02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.939638282615e+02 lambda=5.0000000000000003e-02 Line search: Cubically determined step, current gnorm 1.787985482018e+02 lambda=1.2647907914070569e-02 46 SNES Function norm 1.787985482018e+02 0 KSP Residual norm 1.225736349281e+01 1 KSP Residual norm 3.819378790812e-13 Line search: gnorm after quadratic fit 4.548006065036e+02 Line search: Cubic step no good, shrinking lambda, current gnorm 2.304803559060e+02 lambda=5.0000000000000003e-02 Line search: Cubically determined step, current gnorm 1.787344729174e+02 lambda=8.9002284237256531e-03 47 SNES Function norm 1.787344729174e+02 0 KSP Residual norm 6.302465402340e+00 1 KSP Residual norm 6.980931947122e-14 Line search: gnorm after quadratic fit 2.879477700004e+02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.980806946742e+02 lambda=5.0000000000000003e-02 Line search: Cubically determined step, current gnorm 1.780128006935e+02 lambda=1.0223293444602008e-02 48 SNES Function norm 1.780128006935e+02 0 KSP Residual norm 4.323829277968e+00 1 KSP Residual norm 5.223881369308e-13 Line search: gnorm after quadratic fit 1.957928151218e+02 Line search: Cubically determined step, current gnorm 1.768899805640e+02 lambda=5.0000000000000003e-02 49 SNES Function norm 1.768899805640e+02 0 KSP Residual norm 2.249256107033e+00 1 KSP Residual norm 3.624400957270e-14 Line search: gnorm after quadratic fit 1.704782114773e+02 Line search: Quadratically determined step, lambda=1.0000000000000001e-01 50 SNES Function norm 1.704782114773e+02 0 SNES Function norm 3.513783397332e+03 0 KSP Residual norm 1.650214950648e+01 1 KSP Residual norm 3.574269752690e-13 Line search: gnorm after quadratic fit 3.155830404050e+03 Line search: Quadratically determined step, lambda=1.0000000000000001e-01 1 SNES Function norm 3.155830404050e+03 0 KSP Residual norm 1.443734018042e+01 1 KSP Residual norm 3.685565191058e-13 Line search: Using full step: fnorm 3.155830404050e+03 gnorm 8.581212204155e+02 2 SNES Function norm 8.581212204155e+02 0 KSP Residual norm 2.492601775565e+00 1 KSP Residual norm 9.698440210389e-14 Line search: Using full step: fnorm 8.581212204155e+02 gnorm 7.018609898542e+02 3 SNES Function norm 7.018609898542e+02 0 KSP Residual norm 1.740320986421e+00 1 KSP Residual norm 2.868780682435e-14 Line search: Using full step: fnorm 7.018609898542e+02 gnorm 2.135824235887e+02 4 SNES Function norm 2.135824235887e+02 0 KSP Residual norm 1.647413497077e+00 1 KSP Residual norm 2.731226225666e-14 Line search: gnorm after quadratic fit 1.936469032649e+02 Line search: Quadratically determined step, lambda=1.0000000000000001e-01 5 SNES Function norm 1.936469032649e+02 0 KSP Residual norm 1.406615972124e+00 1 KSP Residual norm 3.167179626699e-14 Line search: gnorm after quadratic fit 1.755362571467e+02 Line search: Quadratically determined step, lambda=1.0000000000000001e-01 6 SNES Function norm 1.755362571467e+02 0 KSP Residual norm 1.480681706594e+00 1 KSP Residual norm 2.935210968935e-14 Line search: gnorm after quadratic fit 1.597659506616e+02 Line search: Quadratically determined step, lambda=1.0000000000000001e-01 7 SNES Function norm 1.597659506616e+02 0 KSP Residual norm 4.013154698097e+00 1 KSP Residual norm 1.021628704832e-13 Line search: gnorm after quadratic fit 1.728408060966e+02 Line search: Cubically determined step, current gnorm 1.570815760721e+02 lambda=5.0000000000000003e-02 8 SNES Function norm 1.570815760721e+02 0 KSP Residual norm 1.510335662636e+00 1 KSP Residual norm 2.728243244724e-14 Line search: gnorm after quadratic fit 1.450162880692e+02 Line search: Quadratically determined step, lambda=1.0000000000000001e-01 9 SNES Function norm 1.450162880692e+02 0 KSP Residual norm 1.923349271077e+01 1 KSP Residual norm 1.640711956406e-11 Line search: gnorm after quadratic fit 1.016537223115e+03 Line search: Cubic step no good, shrinking lambda, current gnorm 3.584263092048e+02 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.490729346583e+02 lambda=9.3725990358703350e-03 Line search: Cubically determined step, current gnorm 1.449349273006e+02 lambda=1.5464889706033082e-03 10 SNES Function norm 1.449349273006e+02 0 KSP Residual norm 1.154999084194e+01 1 KSP Residual norm 1.292167633338e-11 Line search: gnorm after quadratic fit 6.060386918705e+02 Line search: Cubic step no good, shrinking lambda, current gnorm 2.236630526035e+02 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.491201927819e+02 lambda=1.6816056300124185e-02 Line search: Cubically determined step, current gnorm 1.447023047013e+02 lambda=4.1484374564153808e-03 11 SNES Function norm 1.447023047013e+02 0 KSP Residual norm 7.278906180502e+00 1 KSP Residual norm 2.815632651924e-12 Line search: gnorm after quadratic fit 2.512278711773e+02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.624350957814e+02 lambda=5.0000000000000003e-02 Line search: Cubically determined step, current gnorm 1.441656049510e+02 lambda=1.0879389002513012e-02 12 SNES Function norm 1.441656049510e+02 0 KSP Residual norm 4.449836480267e+00 1 KSP Residual norm 3.152365624813e-13 Line search: gnorm after quadratic fit 1.749680739878e+02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.458763435996e+02 lambda=5.0000000000000003e-02 Line search: Cubically determined step, current gnorm 1.425715025152e+02 lambda=2.2766809271842225e-02 13 SNES Function norm 1.425715025152e+02 0 KSP Residual norm 4.218495037726e+00 1 KSP Residual norm 1.398472536142e-12 Line search: gnorm after quadratic fit 1.645159536467e+02 Line search: Cubically determined step, current gnorm 1.421991559212e+02 lambda=4.1883769431247941e-02 14 SNES Function norm 1.421991559212e+02 0 KSP Residual norm 1.968853538608e+00 1 KSP Residual norm 7.594023450519e-12 Line search: gnorm after quadratic fit 1.350960142124e+02 Line search: Quadratically determined step, lambda=1.0000000000000001e-01 15 SNES Function norm 1.350960142124e+02 0 KSP Residual norm 3.444721686085e+00 1 KSP Residual norm 5.312609674019e-14 Line search: gnorm after quadratic fit 1.472880565107e+02 Line search: Cubically determined step, current gnorm 1.336714620145e+02 lambda=4.1341550820829437e-02 16 SNES Function norm 1.336714620145e+02 0 KSP Residual norm 3.276288899397e+00 1 KSP Residual norm 8.394674946715e-14 Line search: gnorm after quadratic fit 1.459274497150e+02 Line search: Cubically determined step, current gnorm 1.327618539486e+02 lambda=5.0000000000000003e-02 17 SNES Function norm 1.327618539486e+02 0 KSP Residual norm 2.630052244303e+00 1 KSP Residual norm 4.351283410507e-14 Line search: gnorm after quadratic fit 1.350378060116e+02 Line search: Cubically determined step, current gnorm 1.299403903934e+02 lambda=4.9913529436269283e-02 18 SNES Function norm 1.299403903934e+02 0 KSP Residual norm 6.124953430138e+00 1 KSP Residual norm 2.295381352938e-13 Line search: gnorm after quadratic fit 2.275621676963e+02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.469611730657e+02 lambda=5.0000000000000003e-02 Line search: Cubically determined step, current gnorm 1.294890694898e+02 lambda=1.0071939100661648e-02 19 SNES Function norm 1.294890694898e+02 0 KSP Residual norm 1.036733907011e+01 1 KSP Residual norm 1.800941381283e-13 Line search: gnorm after quadratic fit 3.844879463595e+02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.875071148504e+02 lambda=5.0000000000000003e-02 Line search: Cubically determined step, current gnorm 1.294494430642e+02 lambda=5.0000000000000010e-03 20 SNES Function norm 1.294494430642e+02 0 KSP Residual norm 8.224001595443e+00 1 KSP Residual norm 3.337810156182e-13 Line search: gnorm after quadratic fit 3.332325263497e+02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.682441841234e+02 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.294720538860e+02 lambda=8.5401597581228530e-03 Line search: Cubically determined step, current gnorm 1.291762382985e+02 lambda=4.2555418164960989e-03 21 SNES Function norm 1.291762382985e+02 0 KSP Residual norm 3.920749219860e+01 1 KSP Residual norm 1.610902886435e-12 Line search: gnorm after quadratic fit 3.472422440640e+03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.023065712859e+03 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 2.228184088700e+02 lambda=1.6004598823093592e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.298607525058e+02 lambda=1.6004598823093593e-03 Line search: Cubically determined step, current gnorm 1.291643460998e+02 lambda=1.9319076533745672e-04 22 SNES Function norm 1.291643460998e+02 0 KSP Residual norm 1.520092314848e+02 1 KSP Residual norm 7.089159192434e-11 Line search: gnorm after quadratic fit 2.752539686422e+05 Line search: Cubic step no good, shrinking lambda, current gnorm 4.237188995536e+04 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 7.484370498858e+03 lambda=2.5000000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.571039994484e+03 lambda=1.2500000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 4.280898858362e+02 lambda=6.2500000000000003e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.708927009106e+02 lambda=2.6114913411793973e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.294919567784e+02 lambda=2.6114913411793975e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 1.291645609810e+02 lambda=2.6114913411793977e-05 Line search: Cubically determined step, current gnorm 1.291635530596e+02 lambda=1.2278773895355162e-05 23 SNES Function norm 1.291635530596e+02 0 KSP Residual norm 7.569206058965e+02 1 KSP Residual norm 3.454693729751e-11 Line search: gnorm after quadratic fit 2.570888738395e+07 Line search: Cubic step no good, shrinking lambda, current gnorm 3.064965025187e+06 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 3.498514098182e+05 lambda=2.5000000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 3.807487005202e+04 lambda=1.2500000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 5.233167830543e+03 lambda=6.2500000000000003e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.396736912757e+03 lambda=3.1250000000000002e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 3.547572543330e+02 lambda=1.2623406091699435e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.335889024473e+02 lambda=1.8542137907683829e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 1.292059042479e+02 lambda=1.8542137907683831e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 1.291637618568e+02 lambda=1.8542137907683832e-06 Line search: Cubically determined step, current gnorm 1.291635210734e+02 lambda=4.9524172913414387e-07 24 SNES Function norm 1.291635210734e+02 0 KSP Residual norm 3.761913422861e+03 1 KSP Residual norm 6.181718776929e-10 Line search: gnorm after quadratic fit 3.342370445037e+09 Line search: Cubic step no good, shrinking lambda, current gnorm 4.218326646111e+08 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 5.375128803204e+07 lambda=2.5000000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 6.980626157021e+06 lambda=1.2500000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 9.407418671219e+05 lambda=6.2500000000000003e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.357321025399e+05 lambda=3.1250000000000002e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 2.188948059047e+04 lambda=1.5625000000000001e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 4.105117929713e+03 lambda=7.8125000000000004e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 9.331054736818e+02 lambda=3.9062500000000002e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 2.942479792843e+02 lambda=1.9412500272460620e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 1.436944624694e+02 lambda=6.4483223307578726e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 1.292972287211e+02 lambda=6.4483223307578726e-06 Line search: Cubic step no good, shrinking lambda, current gnorm 1.291647778160e+02 lambda=6.4483223307578730e-07 Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635261433e+02 lambda=6.4483223307578730e-08 Line search: Cubically determined step, current gnorm 1.291635197798e+02 lambda=2.0042115918485846e-08 25 SNES Function norm 1.291635197798e+02 0 KSP Residual norm 1.874745766083e+04 1 KSP Residual norm 1.476978150334e-09 Line search: gnorm after quadratic fit 4.089262111368e+11 Line search: Cubic step no good, shrinking lambda, current gnorm 5.101717203770e+10 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 6.352565940292e+09 lambda=2.5000000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 7.879613196620e+08 lambda=1.2500000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 9.698613558125e+07 lambda=6.2500000000000003e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.175566265039e+07 lambda=3.1250000000000002e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.382919964952e+06 lambda=1.5625000000000001e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.545431975334e+05 lambda=7.8125000000000004e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 1.713561369103e+04 lambda=3.9062500000000002e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 3.031789308419e+03 lambda=1.9531250000000001e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 9.205847020738e+02 lambda=9.7656250000000005e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 1.957203153158e+02 lambda=2.8132879163728503e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 1.297923302791e+02 lambda=2.8132879163728504e-06 Line search: Cubic step no good, shrinking lambda, current gnorm 1.291698100579e+02 lambda=2.8132879163728504e-07 Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635794525e+02 lambda=2.8132879163728506e-08 Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635200489e+02 lambda=2.8132879163728508e-09 Line search: Cubically determined step, current gnorm 1.291635197275e+02 lambda=8.0832061492461345e-10 26 SNES Function norm 1.291635197275e+02 0 KSP Residual norm 9.248381077528e+04 1 KSP Residual norm 7.262307068447e-09 Line search: gnorm after quadratic fit 4.920647210624e+13 Line search: Cubic step no good, shrinking lambda, current gnorm 6.153216818065e+12 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 7.697543960375e+11 lambda=2.5000000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 9.637004379805e+10 lambda=1.2500000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.208402653149e+10 lambda=6.2500000000000003e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.519988135798e+09 lambda=3.1250000000000002e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.923903214787e+08 lambda=1.5625000000000001e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 2.465663001976e+07 lambda=7.8125000000000004e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 3.238603967195e+06 lambda=3.9062500000000002e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 4.459179143177e+05 lambda=1.9531250000000001e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 6.676301042792e+04 lambda=9.7656250000000005e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 1.135808875752e+04 lambda=4.8828125000000003e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 2.275714918657e+03 lambda=2.4414062500000001e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 5.719037747616e+02 lambda=1.2207031250000001e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 2.039826156716e+02 lambda=5.5609199181402721e-06 Line search: Cubic step no good, shrinking lambda, current gnorm 1.308092967809e+02 lambda=9.1057337296683134e-07 Line search: Cubic step no good, shrinking lambda, current gnorm 1.291796742824e+02 lambda=9.1057337296683134e-08 Line search: Cubic step no good, shrinking lambda, current gnorm 1.291636800174e+02 lambda=9.1057337296683134e-09 Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635212255e+02 lambda=9.1057337296683134e-10 Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635197320e+02 lambda=9.1057337296683139e-11 Line search: Cubically determined step, current gnorm 1.291635197254e+02 lambda=3.2898162617097329e-11 27 SNES Function norm 1.291635197254e+02 0 KSP Residual norm 4.818745996826e+05 1 KSP Residual norm 3.300979345194e-08 Line search: gnorm after quadratic fit 6.957046028867e+15 Line search: Cubic step no good, shrinking lambda, current gnorm 8.695654311477e+14 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.086793500688e+14 lambda=2.5000000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.358083744813e+13 lambda=1.2500000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.696584801696e+12 lambda=6.2500000000000003e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 2.118183549773e+11 lambda=3.1250000000000002e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 2.641372080976e+10 lambda=1.5625000000000001e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 3.285878535769e+09 lambda=7.8125000000000004e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 4.068045470276e+08 lambda=3.9062500000000002e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 4.988290932539e+07 lambda=1.9531250000000001e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 6.001404304764e+06 lambda=9.7656250000000005e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 6.962234585736e+05 lambda=4.8828125000000003e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 7.648190078115e+04 lambda=2.4414062500000001e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 9.098288624714e+03 lambda=1.2207031250000001e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 2.025132922751e+03 lambda=6.1035156250000003e-06 Line search: Cubic step no good, shrinking lambda, current gnorm 6.536770142392e+02 lambda=3.0517578125000002e-06 Line search: Cubic step no good, shrinking lambda, current gnorm 1.529553964021e+02 lambda=6.6615844706846272e-07 Line search: Cubic step no good, shrinking lambda, current gnorm 1.293970371303e+02 lambda=6.6615844706846277e-08 Line search: Cubic step no good, shrinking lambda, current gnorm 1.291658631829e+02 lambda=6.6615844706846284e-09 Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635430890e+02 lambda=6.6615844706846284e-10 Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635199508e+02 lambda=6.6615844706846284e-11 Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635197268e+02 lambda=6.6615844706846284e-12 Line search: Cubically determined step, current gnorm 1.291635197253e+02 lambda=1.2496728806533799e-12 28 SNES Function norm 1.291635197253e+02 0 KSP Residual norm 2.124622394867e+06 1 KSP Residual norm 2.766225333896e-07 Line search: gnorm after quadratic fit 5.963587884154e+17 Line search: Cubic step no good, shrinking lambda, current gnorm 7.454611858824e+16 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 9.318582340500e+15 lambda=2.5000000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.164902175749e+15 lambda=1.2500000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.456326197371e+14 lambda=6.2500000000000003e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.820904039469e+13 lambda=3.1250000000000002e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 2.277371273495e+12 lambda=1.5625000000000001e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 2.849819609184e+11 lambda=7.8125000000000004e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 3.570050545145e+10 lambda=3.9062500000000002e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 4.482064028328e+09 lambda=1.9531250000000001e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 5.651631635063e+08 lambda=9.7656250000000005e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 7.188623828904e+07 lambda=4.8828125000000003e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 9.302868645305e+06 lambda=2.4414062500000001e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 1.245214424313e+06 lambda=1.2207031250000001e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 1.775004618570e+05 lambda=6.1035156250000003e-06 Line search: Cubic step no good, shrinking lambda, current gnorm 2.810228834086e+04 lambda=3.0517578125000002e-06 Line search: Cubic step no good, shrinking lambda, current gnorm 5.148910945566e+03 lambda=1.5258789062500001e-06 Line search: Cubic step no good, shrinking lambda, current gnorm 1.133679879416e+03 lambda=7.6293945312500004e-07 Line search: Cubic step no good, shrinking lambda, current gnorm 3.382468615011e+02 lambda=3.8146972656250002e-07 Line search: Cubic step no good, shrinking lambda, current gnorm 1.519773483633e+02 lambda=1.4103864371136453e-07 Line search: Cubic step no good, shrinking lambda, current gnorm 1.293690599792e+02 lambda=1.4103864371136454e-08 Line search: Cubic step no good, shrinking lambda, current gnorm 1.291655645282e+02 lambda=1.4103864371136455e-09 Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635401518e+02 lambda=1.4103864371136456e-10 Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635199283e+02 lambda=1.4103864371136456e-11 Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635197272e+02 lambda=1.4103864371136456e-12 Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635197253e+02 lambda=1.4103864371136457e-13 Line search: unable to find good step length! After 25 tries Line search: fnorm=1.2916351972528861e+02, gnorm=1.2916351972529532e+02, ynorm=2.1246218291095798e+06, minlambda=9.9999999999999998e-13, lambda=1.4103864371136457e-13, initial slope=-1.6683210999382733e+04 0 SNES Function norm 7.158176401507e+03 0 KSP Residual norm 7.545626598553e+02 1 KSP Residual norm 2.192822940623e-11 Line search: gnorm after quadratic fit 6.003975664723e+07 Line search: Cubic step no good, shrinking lambda, current gnorm 7.501930637484e+06 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 9.380142516806e+05 lambda=2.5000000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.179837352860e+05 lambda=1.2500000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.656902039419e+04 lambda=6.2500000000000003e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 7.340091686120e+03 lambda=3.1250000000000002e-03 Line search: Cubically determined step, current gnorm 7.127478647243e+03 lambda=1.5625000000000001e-03 1 SNES Function norm 7.127478647243e+03 0 KSP Residual norm 3.139792512249e+01 1 KSP Residual norm 5.765552480238e-13 Line search: gnorm after quadratic fit 7.131728282938e+03 Line search: Cubically determined step, current gnorm 6.730387269330e+03 lambda=5.0000000000000003e-02 2 SNES Function norm 6.730387269330e+03 0 KSP Residual norm 2.247436817553e+01 1 KSP Residual norm 4.129717651221e-13 Line search: gnorm after quadratic fit 6.018304311910e+03 Line search: Quadratically determined step, lambda=1.0000000000000001e-01 3 SNES Function norm 6.018304311910e+03 0 KSP Residual norm 1.605973421081e+01 1 KSP Residual norm 3.614891198134e-13 Line search: gnorm after quadratic fit 5.394599276028e+03 Line search: Quadratically determined step, lambda=1.0000000000000001e-01 4 SNES Function norm 5.394599276028e+03 0 KSP Residual norm 1.491002227850e+01 1 KSP Residual norm 5.905756964447e-13 Line search: gnorm after quadratic fit 4.845108544722e+03 Line search: Quadratically determined step, lambda=1.0000000000000001e-01 5 SNES Function norm 4.845108544722e+03 0 KSP Residual norm 1.562997766581e+02 1 KSP Residual norm 5.722461855805e-12 Line search: gnorm after quadratic fit 1.663505509947e+05 Line search: Cubic step no good, shrinking lambda, current gnorm 2.368547472010e+04 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 6.067825049920e+03 lambda=2.5000000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 4.852173464442e+03 lambda=1.2500000000000001e-02 Line search: Cubically determined step, current gnorm 4.819549937425e+03 lambda=6.2500000000000003e-03 6 SNES Function norm 4.819549937425e+03 0 KSP Residual norm 1.652787385042e+01 1 KSP Residual norm 7.774483442550e-13 Line search: gnorm after quadratic fit 2.868840270198e+03 Line search: Quadratically determined step, lambda=3.9586658383856743e-01 7 SNES Function norm 2.868840270198e+03 0 KSP Residual norm 1.220061851091e+01 1 KSP Residual norm 4.785407437718e-13 Line search: gnorm after quadratic fit 2.616720732407e+03 Line search: Quadratically determined step, lambda=1.0000000000000001e-01 8 SNES Function norm 2.616720732407e+03 0 KSP Residual norm 2.884722153958e+01 1 KSP Residual norm 5.474553921306e-13 Line search: gnorm after quadratic fit 3.025386805317e+03 Line search: Cubically determined step, current gnorm 2.572110173067e+03 lambda=5.0000000000000003e-02 9 SNES Function norm 2.572110173067e+03 0 KSP Residual norm 5.239447686736e+01 1 KSP Residual norm 1.006906008399e-12 Line search: gnorm after quadratic fit 5.237562098046e+03 Line search: Cubic step no good, shrinking lambda, current gnorm 2.722529781980e+03 lambda=5.0000000000000003e-02 Line search: Cubically determined step, current gnorm 2.553072891461e+03 lambda=2.5000000000000001e-02 10 SNES Function norm 2.553072891461e+03 0 KSP Residual norm 6.511316788880e+00 1 KSP Residual norm 1.340296659008e-13 Line search: gnorm after quadratic fit 2.299704119080e+03 Line search: Quadratically determined step, lambda=1.0000000000000001e-01 11 SNES Function norm 2.299704119080e+03 0 KSP Residual norm 5.268131426587e+00 1 KSP Residual norm 1.017563310127e-13 Line search: Using full step: fnorm 2.299704119080e+03 gnorm 7.642690039388e+02 12 SNES Function norm 7.642690039388e+02 0 KSP Residual norm 1.467735721574e+01 1 KSP Residual norm 1.090242963543e-12 Line search: gnorm after quadratic fit 1.042766084830e+03 Line search: Cubic step no good, shrinking lambda, current gnorm 7.924803860137e+02 lambda=5.0000000000000003e-02 Line search: Cubically determined step, current gnorm 7.581126971182e+02 lambda=1.8508848315139208e-02 13 SNES Function norm 7.581126971182e+02 0 KSP Residual norm 2.222609581896e+00 1 KSP Residual norm 5.661437314341e-14 Line search: gnorm after quadratic fit 6.235337602260e+02 Line search: Quadratically determined step, lambda=2.1172883827013136e-01 14 SNES Function norm 6.235337602260e+02 0 KSP Residual norm 3.080209609798e+00 1 KSP Residual norm 6.073476899313e-14 Line search: gnorm after quadratic fit 5.704745248520e+02 Line search: Quadratically determined step, lambda=1.0142301129466913e-01 15 SNES Function norm 5.704745248520e+02 0 KSP Residual norm 5.628316803979e+00 1 KSP Residual norm 9.930477041779e-14 Line search: gnorm after quadratic fit 5.401354794776e+02 Line search: Quadratically determined step, lambda=1.0000000000000001e-01 16 SNES Function norm 5.401354794776e+02 0 KSP Residual norm 2.052541406719e+01 1 KSP Residual norm 4.328836834239e-13 Line search: gnorm after quadratic fit 1.709850100987e+03 Line search: Cubic step no good, shrinking lambda, current gnorm 7.717966555703e+02 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 5.414032576976e+02 lambda=8.7805694170804971e-03 Line search: Cubically determined step, current gnorm 5.391967144330e+02 lambda=3.6341472475199424e-03 17 SNES Function norm 5.391967144330e+02 0 KSP Residual norm 2.246993769488e+00 1 KSP Residual norm 5.078373642913e-14 Line search: gnorm after quadratic fit 4.939618639951e+02 Line search: Quadratically determined step, lambda=1.0000000000000001e-01 18 SNES Function norm 4.939618639951e+02 0 KSP Residual norm 2.155867648564e+00 1 KSP Residual norm 4.438622106380e-14 Line search: gnorm after quadratic fit 4.334377322188e+02 Line search: Quadratically determined step, lambda=1.5092486954829210e-01 19 SNES Function norm 4.334377322188e+02 0 KSP Residual norm 8.318284791610e+00 1 KSP Residual norm 6.910116607023e-13 Line search: gnorm after quadratic fit 6.148799641401e+02 Line search: Cubic step no good, shrinking lambda, current gnorm 4.502386288041e+02 lambda=5.0000000000000003e-02 Line search: Cubically determined step, current gnorm 4.297879862602e+02 lambda=1.9565738732695813e-02 20 SNES Function norm 4.297879862602e+02 0 KSP Residual norm 7.593855254976e+01 1 KSP Residual norm 1.300639045149e-12 Line search: gnorm after quadratic fit 7.318016560287e+04 Line search: Cubic step no good, shrinking lambda, current gnorm 7.832525429452e+03 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.543595712952e+03 lambda=2.5000000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 6.752901058720e+02 lambda=1.2500000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 4.309726315570e+02 lambda=1.2500000000000002e-03 Line search: Cubically determined step, current gnorm 4.297464967378e+02 lambda=2.0986409143217158e-04 21 SNES Function norm 4.297464967378e+02 0 KSP Residual norm 8.492609701850e+00 1 KSP Residual norm 2.830329105288e-13 Line search: gnorm after quadratic fit 6.575200413213e+02 Line search: Cubic step no good, shrinking lambda, current gnorm 4.532760802544e+02 lambda=5.0000000000000003e-02 Line search: Cubically determined step, current gnorm 4.268212296998e+02 lambda=1.8460064973695799e-02 22 SNES Function norm 4.268212296998e+02 0 KSP Residual norm 2.527155905469e+00 1 KSP Residual norm 2.235724978394e-13 Line search: gnorm after quadratic fit 3.958132075117e+02 Line search: Quadratically determined step, lambda=1.0000000000000001e-01 23 SNES Function norm 3.958132075117e+02 0 KSP Residual norm 3.425644398425e+00 1 KSP Residual norm 7.166017790799e-14 Line search: gnorm after quadratic fit 3.803199338641e+02 Line search: Quadratically determined step, lambda=1.0000000000000001e-01 24 SNES Function norm 3.803199338641e+02 0 KSP Residual norm 3.581435186688e+00 1 KSP Residual norm 1.730091027109e-13 Line search: gnorm after quadratic fit 3.678433353709e+02 Line search: Quadratically determined step, lambda=1.0000000000000001e-01 25 SNES Function norm 3.678433353709e+02 0 KSP Residual norm 2.817439291614e+00 1 KSP Residual norm 8.592333136485e-13 Line search: gnorm after quadratic fit 3.472671313564e+02 Line search: Quadratically determined step, lambda=1.0000000000000001e-01 26 SNES Function norm 3.472671313564e+02 0 KSP Residual norm 1.830066839089e+00 1 KSP Residual norm 3.248934231575e-14 Line search: gnorm after quadratic fit 3.195079998571e+02 Line search: Quadratically determined step, lambda=1.0000000000000001e-01 27 SNES Function norm 3.195079998571e+02 0 KSP Residual norm 3.775823654589e+00 1 KSP Residual norm 1.316233059492e-13 Line search: gnorm after quadratic fit 3.252874639934e+02 Line search: Cubically determined step, current gnorm 3.125168318399e+02 lambda=5.0000000000000003e-02 28 SNES Function norm 3.125168318399e+02 0 KSP Residual norm 3.892613775622e+00 1 KSP Residual norm 7.093200713216e-11 Line search: gnorm after quadratic fit 3.137590389484e+02 Line search: Cubically determined step, current gnorm 3.045559021319e+02 lambda=5.0000000000000003e-02 29 SNES Function norm 3.045559021319e+02 0 KSP Residual norm 2.364531179390e+00 1 KSP Residual norm 1.615423543115e-12 Line search: gnorm after quadratic fit 2.864449141431e+02 Line search: Quadratically determined step, lambda=1.0000000000000001e-01 30 SNES Function norm 2.864449141431e+02 0 KSP Residual norm 5.187063704081e+00 1 KSP Residual norm 4.254799504045e-13 Line search: gnorm after quadratic fit 3.171238299438e+02 Line search: Cubically determined step, current gnorm 2.859321807369e+02 lambda=4.9550691080557742e-02 31 SNES Function norm 2.859321807369e+02 0 KSP Residual norm 2.400449127985e+01 1 KSP Residual norm 5.221032480453e-13 Line search: gnorm after quadratic fit 1.812538817802e+03 Line search: Cubic step no good, shrinking lambda, current gnorm 6.647888939229e+02 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 2.905120335847e+02 lambda=7.3371687404129469e-03 Line search: Cubically determined step, current gnorm 2.857698450683e+02 lambda=1.3231746793531958e-03 32 SNES Function norm 2.857698450683e+02 0 KSP Residual norm 7.438521293559e+00 1 KSP Residual norm 1.293652874831e-12 Line search: gnorm after quadratic fit 3.600694148787e+02 Line search: Cubic step no good, shrinking lambda, current gnorm 2.932936811991e+02 lambda=5.0000000000000003e-02 Line search: Cubically determined step, current gnorm 2.832774969882e+02 lambda=1.8636088141277370e-02 33 SNES Function norm 2.832774969882e+02 0 KSP Residual norm 2.676138557891e+00 1 KSP Residual norm 5.204105674042e-12 Line search: gnorm after quadratic fit 2.698470565576e+02 Line search: Quadratically determined step, lambda=1.0000000000000001e-01 34 SNES Function norm 2.698470565576e+02 0 KSP Residual norm 1.009562156863e+01 1 KSP Residual norm 3.544140587695e-13 Line search: gnorm after quadratic fit 5.672695948559e+02 Line search: Cubic step no good, shrinking lambda, current gnorm 3.197216154647e+02 lambda=5.0000000000000003e-02 Line search: Cubically determined step, current gnorm 2.694068135292e+02 lambda=1.0762403784106927e-02 35 SNES Function norm 2.694068135292e+02 0 KSP Residual norm 3.927549314525e+00 1 KSP Residual norm 2.619134786598e-13 Line search: gnorm after quadratic fit 2.646675787349e+02 Line search: Quadratically determined step, lambda=1.0000000000000001e-01 36 SNES Function norm 2.646675787349e+02 0 KSP Residual norm 3.630219417922e+01 1 KSP Residual norm 1.546302717349e-12 Line search: gnorm after quadratic fit 1.827432666108e+04 Line search: Cubic step no good, shrinking lambda, current gnorm 3.342968941151e+03 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 8.008633273369e+02 lambda=2.5000000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 3.490753494196e+02 lambda=1.2345129233072847e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 2.682474011960e+02 lambda=3.3291959087019770e-03 Line search: Cubically determined step, current gnorm 2.646227701989e+02 lambda=4.0529212866107715e-04 37 SNES Function norm 2.646227701989e+02 0 KSP Residual norm 8.122774697994e+00 1 KSP Residual norm 1.316362046092e-13 Line search: gnorm after quadratic fit 4.731092571363e+02 Line search: Cubic step no good, shrinking lambda, current gnorm 3.030088374328e+02 lambda=5.0000000000000003e-02 Line search: Cubically determined step, current gnorm 2.637462652877e+02 lambda=9.1057248517509397e-03 38 SNES Function norm 2.637462652877e+02 0 KSP Residual norm 2.601520363063e+00 1 KSP Residual norm 1.060764270007e-12 Line search: gnorm after quadratic fit 2.536856446094e+02 Line search: Quadratically determined step, lambda=1.0000000000000001e-01 39 SNES Function norm 2.536856446094e+02 0 KSP Residual norm 5.447955134327e+01 1 KSP Residual norm 2.556989975730e-12 Line search: gnorm after quadratic fit 9.199250935618e+03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.998238940105e+03 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 6.227083769291e+02 lambda=2.5000000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 2.852215674478e+02 lambda=8.5024965111563117e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 2.537821339347e+02 lambda=8.5024965111563122e-04 Line search: Cubically determined step, current gnorm 2.536484146652e+02 lambda=2.9594242443314720e-04 40 SNES Function norm 2.536484146652e+02 0 KSP Residual norm 3.357359266965e+01 1 KSP Residual norm 8.485166742752e-11 Line search: gnorm after quadratic fit 3.327150899857e+03 Line search: Cubic step no good, shrinking lambda, current gnorm 8.660943990394e+02 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 3.428891921377e+02 lambda=2.2262238648584176e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 2.550059920785e+02 lambda=3.9120439672600755e-03 Line search: Cubically determined step, current gnorm 2.535425543202e+02 lambda=8.8078244093807846e-04 41 SNES Function norm 2.535425543202e+02 0 KSP Residual norm 1.982789391732e+01 1 KSP Residual norm 1.156473750758e-11 Line search: gnorm after quadratic fit 9.648483369708e+02 Line search: Cubic step no good, shrinking lambda, current gnorm 4.023504841042e+02 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 2.554919970151e+02 lambda=8.7092873850291869e-03 Line search: Cubically determined step, current gnorm 2.532490636747e+02 lambda=2.4564558988847251e-03 42 SNES Function norm 2.532490636747e+02 0 KSP Residual norm 1.762994613361e+01 1 KSP Residual norm 4.550684860593e-12 Line search: gnorm after quadratic fit 6.772107527838e+02 Line search: Cubic step no good, shrinking lambda, current gnorm 3.370541870778e+02 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 2.532869639177e+02 lambda=7.7662700854918328e-03 Line search: Cubically determined step, current gnorm 2.527651129995e+02 lambda=3.8686733161537824e-03 43 SNES Function norm 2.527651129995e+02 0 KSP Residual norm 1.559278923951e+01 1 KSP Residual norm 1.060470887103e-11 Line search: gnorm after quadratic fit 7.344361373020e+02 Line search: Cubic step no good, shrinking lambda, current gnorm 3.498001534426e+02 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 2.530518382567e+02 lambda=7.6730113050967469e-03 Line search: Cubically determined step, current gnorm 2.523423548732e+02 lambda=3.4156098513217236e-03 44 SNES Function norm 2.523423548732e+02 0 KSP Residual norm 1.190500639095e+01 1 KSP Residual norm 6.311739265577e-12 Line search: gnorm after quadratic fit 4.875196633557e+02 Line search: Cubic step no good, shrinking lambda, current gnorm 2.933215922947e+02 lambda=5.0000000000000003e-02 Line search: Cubically determined step, current gnorm 2.516782376717e+02 lambda=9.8878729665301743e-03 45 SNES Function norm 2.516782376717e+02 0 KSP Residual norm 1.003632001309e+01 1 KSP Residual norm 7.039473047666e-13 Line search: gnorm after quadratic fit 3.417133560813e+02 Line search: Cubic step no good, shrinking lambda, current gnorm 2.636443273929e+02 lambda=5.0000000000000003e-02 Line search: Cubically determined step, current gnorm 2.499729768042e+02 lambda=1.5332495922160540e-02 46 SNES Function norm 2.499729768042e+02 0 KSP Residual norm 5.252587112411e+01 1 KSP Residual norm 2.072629114336e-12 Line search: gnorm after quadratic fit 7.891803681498e+03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.819076698717e+03 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 5.911876424956e+02 lambda=2.4538865368827514e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 2.688195882303e+02 lambda=6.5764457912135515e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 2.500076295129e+02 lambda=6.5764457912135523e-04 Line search: Cubically determined step, current gnorm 2.499390700783e+02 lambda=2.7231956365922875e-04 47 SNES Function norm 2.499390700783e+02 0 KSP Residual norm 4.007648116930e+01 1 KSP Residual norm 5.646654234336e-11 Line search: gnorm after quadratic fit 6.276152857499e+03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.418274035925e+03 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 4.785345842563e+02 lambda=2.5000000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 2.665412152699e+02 lambda=8.0607289886479045e-03 Line search: Cubically determined step, current gnorm 2.499109739904e+02 lambda=8.0607289886479045e-04 48 SNES Function norm 2.499109739904e+02 0 KSP Residual norm 1.339756751889e+01 1 KSP Residual norm 2.559175980945e-13 Line search: gnorm after quadratic fit 6.052259901869e+02 Line search: Cubic step no good, shrinking lambda, current gnorm 3.217431518450e+02 lambda=5.0000000000000003e-02 Line search: Cubically determined step, current gnorm 2.496541765916e+02 lambda=7.0239599632283649e-03 49 SNES Function norm 2.496541765916e+02 0 KSP Residual norm 5.340771873687e+00 1 KSP Residual norm 1.207454778077e-13 Line search: gnorm after quadratic fit 2.760767095070e+02 Line search: Cubically determined step, current gnorm 2.491630276458e+02 lambda=5.0000000000000003e-02 50 SNES Function norm 2.491630276458e+02 On Sat, Aug 26, 2017 at 11:45 PM, Barry Smith wrote: > > > On Aug 26, 2017, at 10:43 PM, zakaryah . wrote: > > > > Hi Barry - many thanks for taking the time to understand my many > problems and providing so much help. > > > > The reason I was concerned that I could not alter the linesearch was > when I tried to use bt instead of the L-BFGS default, cp, the code crashed > with an error like "Could not get Jacobian". Maybe this is an > incompatibility like you say, since L-BFGS only uses the initial Jacobian > and I never tried setting the scale type. > > > > I took your advice and tried to shrink the problem. First I tried > shrinking by a factor 1000 but this converged very quickly with all test > data I could provide, including the data which was problematic with the > large grid. So I settled for a reduction in size by a factor 125. The > grid size is 13,230. This is a decent test case because the solver fails > to converge with the options I was using before, and it is small enough > that I can run it with the options you suggested (-snes_fd_color -snes_type > newtonls -snes_monitor -snes_linesearch_monitor -ksp_monitor -pc_type lu). > > > > The output is 1800 lines long - how shall I share it? > > Just email it, that is small enough for email. > > Barry > > > > > > > > > > > On Sat, Aug 26, 2017 at 7:38 PM, Barry Smith wrote: > > > > > On Aug 26, 2017, at 5:56 PM, zakaryah . wrote: > > > > > > I'm using PETSc's SNES methods to solve PDEs which result from > Euler-Lagrange equations for the strain energy of a 3D displacement field. > There is an additional term in the Lagrangian which describes external > forces which arise from various data sets, and that term contains > nonlinearities (field terms higher than linear). The grid has about 1.6e6 > elements, and the displacement field has 3 components at each grid element. > > > > > > I'm trying to solve a sequence of successively more complicated > equations, and the latest equation is failing to converge on some data > sets. In particular, the methods were successful for the infinitesimal bulk > strain (compression) energy, as well as the full infinitesimal strain > energy (bulk + shear), but I'm now trying to generalize to the finite > strain, as certain data sets are known to result from displacement fields > for which the infinitesimal strain is a poor approximation. > > > > > > I'm using a DMDA, closely following example 48, and my preferred > solver is L-BFGS. > > > > So you are using ? > > > > -snes_type qn -snes_qn_type lbfgs > > > > > > > > I have read the FAQs "Why is Newton's method not converging??" and > "Why is my iterative linear solver not converging??"? which have raised a > number of questions: > > > > Quasi Newton methods either don't use Jacobians or use only the > initial Jacobian (the idea behind quasi-Newton methods is to approximate > Jacobian information from previous iterations without having the user > compute a Jacobian at each iteration). With PETSc's qn it only uses the > Jacobian if you use the option > > > > -snes_qn_scale_type Jacobian > > > > otherwise the Jacobian is never computed or used > > > > > > > > > > Is there documentation for the DMDA/SNES methods somewhere? I don't > understand these very well. For example, I am not allocating any matrix > for the global Jacobian, and I believe this prevents me from changing the > line search. If I'm mistaken I would love to see an example of changing > the line search type while using DMDA/SNES. > > > > Whether you provide a Jacobian or not is orthogonal to the line > search. > > > > You should be able to change the line search with > > > > -snes_linesearch_type bt or nleqerr or basic or l2 or cp > > > > not all of them may work with qn > > > > > > > > > > I don't know how to interpret the linesearch monitor. Even for > problems which are converging properly, the linesearch monitor reports > "lssucceed=0" on every iteration. Is this a problem? > > > > It returns a 0 if the line search does not believe it has achieved > "sufficient decrease" in the function norm (or possibly some other measure > of decrease) you should run -snes_linesearch_monitor also with the option > -snes_monitor to see what is happening to the function norm > > > > For qn you can add the option > > > > -snes_qn_monitor > > > > to get more detailed monitoring > > > > > > > > > > I'm also having trouble understanding the methods for > troubleshooting. I suspect that I've made an error in the analytical > Jacobian, which has a rather large number of non-zero elements, but I have > no idea how to use -snes_type test -snes_test_display. The FAQs mention > that some troubleshooting tools are more useful for small test problems. > How small is small? > > > > Tiny, at most a few dozen rows and columns in the Jacobin. > > > > You should run without the -snes_test_display information, what does > it say? Does it indicate the Jacobian or report there is likely a problem? > > > > With DMDA you can also use -snes_fd_color to have PETSc compute the > Jacobian for you instead of using your analytical form. If it works with > this, but not your Jacobian then your Jacobian is wrong. > > > > > When I try to run the program with -snes_type test > -snes_test_display, I get errors like: > > > > > > [0]PETSC ERROR: Argument out of range [0]PETSC ERROR: Local index > 1076396032 too large 4979879 (max) at 0 > > > > > > The second size is 1 less than the number of field elements, while the > first number seems too large for any aspect of the problem - the Jacobian > has at most 59 non-zero columns per row. > > > > > > Because I suspect a possible error in the Jacobian, I ran with > -snes_mf_operator -pc_type ksp -ksp_ksp_rtol 1e-12 and observed very > similar failure to converge (diverging residual) as with the explicit > Jacobian. > > > > What do you get with -ksp_monitor -ksp_ksp_monitor it sounds like > the true Jacobian is either very ill-conditioned or your function > evaluation is wrong. > > > > > Do I need to set an SNES method which is somehow compatible with the > "matrix-free" approach? If I instead use -snes_mf, the problem seems to > converge, but horrendously slowly (true residual relative decrease by about > 1e-5 per iteration). I suppose this supports my suspicion that the > Jacobian is incorrect but doesn't really suggest a solution. > > > > > > Is it possible that the analytical Jacobian is correct, but somehow > pathological, which causes the SNES to diverge? > > > > Yes > > > > > Neither the Jacobian nor the function have singularities. > > > > > > Thanks for any help you can provide! > > > > Try really hard to set up a small problem (like just use a very > coarse grid) to experiment with as you try to get convergence. Using a big > problem for debugging convergence is a recipe for pain. > > > > Also since you have a Jacobian I would start with -snes_fd_color > -snes_type ls -snes_monitor -snes_linesearch_monitor -ksp_monitor -pc_type > lu (not on a huge problem), what happens? Send the output > > > > Barry > > > > > > > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Sat Aug 26 22:52:52 2017 From: bsmith at mcs.anl.gov (Barry Smith) Date: Sat, 26 Aug 2017 22:52:52 -0500 Subject: [petsc-users] A number of questions about DMDA with SNES and Quasi-Newton methods In-Reply-To: References: <020DAED9-AAAD-4741-976B-BB2EF6C79D3F@mcs.anl.gov> <5BF530F6-8D79-47E6-B2C5-B0702FF2AA59@mcs.anl.gov> Message-ID: <7EE84495-4346-4BFB-B9AD-BCAA3C722461@mcs.anl.gov> My exact options did you run with? > On Aug 26, 2017, at 10:48 PM, zakaryah . wrote: > > Here's the output, from the data set which does not converge with l-bfgs: > > 0 SNES Function norm 1.370293318432e+04 > 0 KSP Residual norm 7.457506389218e+02 > 1 KSP Residual norm 2.244764079994e-10 > Line search: gnorm after quadratic fit 6.541298279196e+05 > Line search: Cubic step no good, shrinking lambda, current gnorm 8.963717927372e+04 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.788909416707e+04 lambda=2.5000000000000001e-02 > Line search: Cubically determined step, current gnorm 1.340565762719e+04 lambda=1.2500000000000001e-02 > 1 SNES Function norm 1.340565762719e+04 > 0 KSP Residual norm 4.096066553372e+02 > 1 KSP Residual norm 3.313671167444e-11 > Line search: gnorm after quadratic fit 1.113749573695e+06 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.406390140546e+05 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.126781917443e+04 lambda=2.5000000000000001e-02 > Line search: Cubically determined step, current gnorm 1.272988597973e+04 lambda=1.2500000000000001e-02 > 2 SNES Function norm 1.272988597973e+04 > 0 KSP Residual norm 8.291344597817e+01 > 1 KSP Residual norm 7.182258362182e-12 > Line search: gnorm after quadratic fit 1.121913743889e+04 > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > 3 SNES Function norm 1.121913743889e+04 > 0 KSP Residual norm 6.830535877014e+01 > 1 KSP Residual norm 3.629826411580e-12 > Line search: gnorm after quadratic fit 9.966344973786e+03 > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > 4 SNES Function norm 9.966344973786e+03 > 0 KSP Residual norm 5.137691531345e+01 > 1 KSP Residual norm 1.954502098181e-12 > Line search: gnorm after quadratic fit 8.905508641232e+03 > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > 5 SNES Function norm 8.905508641232e+03 > 0 KSP Residual norm 4.295019262963e+01 > 1 KSP Residual norm 1.581527994925e-12 > Line search: gnorm after quadratic fit 7.599173694189e+03 > Line search: Quadratically determined step, lambda=1.4157226463489950e-01 > 6 SNES Function norm 7.599173694189e+03 > 0 KSP Residual norm 3.520472291520e+01 > 1 KSP Residual norm 1.169994130568e-12 > Line search: gnorm after quadratic fit 6.797214843928e+03 > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > 7 SNES Function norm 6.797214843928e+03 > 0 KSP Residual norm 2.683523206056e+01 > 1 KSP Residual norm 9.039858014119e-13 > Line search: gnorm after quadratic fit 6.098038917364e+03 > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > 8 SNES Function norm 6.098038917364e+03 > 0 KSP Residual norm 2.300710560681e+01 > 1 KSP Residual norm 1.010402303464e-12 > Line search: gnorm after quadratic fit 5.486151385552e+03 > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > 9 SNES Function norm 5.486151385552e+03 > 0 KSP Residual norm 2.824628827619e+01 > 1 KSP Residual norm 1.009589866569e-12 > Line search: gnorm after quadratic fit 4.964991021247e+03 > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > 10 SNES Function norm 4.964991021247e+03 > 0 KSP Residual norm 6.285926028595e+01 > 1 KSP Residual norm 2.833546214180e-12 > Line search: gnorm after quadratic fit 2.100041391472e+04 > Line search: Cubic step no good, shrinking lambda, current gnorm 5.804051080767e+03 lambda=5.0000000000000003e-02 > Line search: Cubically determined step, current gnorm 4.893296169579e+03 lambda=2.5000000000000001e-02 > 11 SNES Function norm 4.893296169579e+03 > 0 KSP Residual norm 1.688978282804e+01 > 1 KSP Residual norm 5.927677470786e-13 > Line search: gnorm after quadratic fit 4.400894622431e+03 > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > 12 SNES Function norm 4.400894622431e+03 > 0 KSP Residual norm 1.481197699600e+01 > 1 KSP Residual norm 4.522572128105e-13 > Line search: Using full step: fnorm 4.400894622431e+03 gnorm 2.094971849007e+03 > 13 SNES Function norm 2.094971849007e+03 > 0 KSP Residual norm 3.514164563318e+00 > 1 KSP Residual norm 3.022385947499e-13 > Line search: gnorm after quadratic fit 1.687641025382e+03 > Line search: Quadratically determined step, lambda=2.0307116693368590e-01 > 14 SNES Function norm 1.687641025382e+03 > 0 KSP Residual norm 2.138591884686e+00 > 1 KSP Residual norm 4.023500814078e-14 > Line search: Using full step: fnorm 1.687641025382e+03 gnorm 1.131934218470e+03 > 15 SNES Function norm 1.131934218470e+03 > 0 KSP Residual norm 3.245035110327e+00 > 1 KSP Residual norm 1.293626215269e-13 > Line search: Using full step: fnorm 1.131934218470e+03 gnorm 7.340573607307e+02 > 16 SNES Function norm 7.340573607307e+02 > 0 KSP Residual norm 1.957698957904e+00 > 1 KSP Residual norm 3.444648967078e-13 > Line search: Using full step: fnorm 7.340573607307e+02 gnorm 5.024723505168e+02 > 17 SNES Function norm 5.024723505168e+02 > 0 KSP Residual norm 2.510538703839e+00 > 1 KSP Residual norm 8.570440675253e-14 > Line search: gnorm after quadratic fit 4.548776456608e+02 > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > 18 SNES Function norm 4.548776456608e+02 > 0 KSP Residual norm 6.741705718178e-01 > 1 KSP Residual norm 1.650556120809e-14 > Line search: Using full step: fnorm 4.548776456608e+02 gnorm 1.351189086642e+02 > 19 SNES Function norm 1.351189086642e+02 > 0 KSP Residual norm 7.653741241950e+00 > 1 KSP Residual norm 8.326848236950e-14 > Line search: gnorm after quadratic fit 4.215455105006e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.889750369356e+02 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.358691836999e+02 lambda=1.0303015930243279e-02 > Line search: Cubically determined step, current gnorm 1.348911963390e+02 lambda=3.5279526770504110e-03 > 20 SNES Function norm 1.348911963390e+02 > 0 KSP Residual norm 4.209281176918e+00 > 1 KSP Residual norm 1.233232881375e-13 > Line search: gnorm after quadratic fit 1.860023264470e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.413911132196e+02 lambda=5.0000000000000003e-02 > Line search: Cubically determined step, current gnorm 1.339597869053e+02 lambda=1.5787957598629023e-02 > 21 SNES Function norm 1.339597869053e+02 > 0 KSP Residual norm 1.718484765841e+00 > 1 KSP Residual norm 6.666016296543e-14 > Line search: gnorm after quadratic fit 1.326878521472e+02 > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > 22 SNES Function norm 1.326878521472e+02 > 0 KSP Residual norm 1.515373499919e+00 > 1 KSP Residual norm 2.259154130795e-12 > Line search: gnorm after quadratic fit 1.226907316391e+02 > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > 23 SNES Function norm 1.226907316391e+02 > 0 KSP Residual norm 1.080252936903e+00 > 1 KSP Residual norm 1.847020526683e-14 > Line search: gnorm after quadratic fit 1.163632111851e+02 > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > 24 SNES Function norm 1.163632111851e+02 > 0 KSP Residual norm 2.491746958382e+00 > 1 KSP Residual norm 6.389134193637e-14 > Line search: gnorm after quadratic fit 1.345487153563e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.169738363622e+02 lambda=4.4108900954515480e-02 > Line search: Cubically determined step, current gnorm 1.152177638108e+02 lambda=1.9997442889243631e-02 > 25 SNES Function norm 1.152177638108e+02 > 0 KSP Residual norm 5.364385501004e+00 > 1 KSP Residual norm 8.457149562463e-14 > Line search: gnorm after quadratic fit 2.722095758964e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.480946353374e+02 lambda=5.0000000000000003e-02 > Line search: Cubically determined step, current gnorm 1.150680255994e+02 lambda=6.3560128131639167e-03 > 26 SNES Function norm 1.150680255994e+02 > 0 KSP Residual norm 4.302025268263e+00 > 1 KSP Residual norm 1.017526937941e-13 > Line search: gnorm after quadratic fit 1.956300983573e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.318600522939e+02 lambda=5.0000000000000003e-02 > Line search: Cubically determined step, current gnorm 1.147123505014e+02 lambda=7.6060788653548803e-03 > 27 SNES Function norm 1.147123505014e+02 > 0 KSP Residual norm 6.195463111324e+00 > 1 KSP Residual norm 1.235283250361e-13 > Line search: gnorm after quadratic fit 3.324821547049e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.612593208504e+02 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.147389525772e+02 lambda=6.1750939181374294e-03 > Line search: Cubically determined step, current gnorm 1.145411432123e+02 lambda=3.0078592586792975e-03 > 28 SNES Function norm 1.145411432123e+02 > 0 KSP Residual norm 1.454704250187e+01 > 1 KSP Residual norm 2.368485174123e-13 > Line search: gnorm after quadratic fit 1.216293873116e+03 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.796524621727e+02 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.359314163651e+02 lambda=1.4867675803955788e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.146009802557e+02 lambda=1.4867675803955788e-03 > Line search: Cubically determined step, current gnorm 1.145096815033e+02 lambda=5.5250912472932839e-04 > 29 SNES Function norm 1.145096815033e+02 > 0 KSP Residual norm 3.430451345093e+01 > 1 KSP Residual norm 1.069396165938e-12 > Line search: gnorm after quadratic fit 1.161329407098e+04 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.260690718050e+03 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 5.696806489042e+02 lambda=2.5000000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.960149915648e+02 lambda=1.1276129246469476e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.158113641658e+02 lambda=1.5873910451430554e-03 > Line search: Cubically determined step, current gnorm 1.145062232916e+02 lambda=1.5873910451430555e-04 > 30 SNES Function norm 1.145062232916e+02 > 0 KSP Residual norm 2.662578971526e+01 > 1 KSP Residual norm 5.464011789728e-13 > Line search: gnorm after quadratic fit 4.375119254490e+03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.038018103928e+03 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.169328002874e+02 lambda=2.3789161387159519e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.262835432714e+02 lambda=5.9737415571960795e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.145626045197e+02 lambda=5.9737415571960802e-04 > Line search: Cubically determined step, current gnorm 1.144968604079e+02 lambda=1.6421773527706333e-04 > 31 SNES Function norm 1.144968604079e+02 > 0 KSP Residual norm 6.322033697338e+01 > 1 KSP Residual norm 1.507157991448e-12 > Line search: gnorm after quadratic fit 5.809243699277e+04 > Line search: Cubic step no good, shrinking lambda, current gnorm 9.460487584142e+03 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.893183483197e+03 lambda=2.5000000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 4.960337007072e+02 lambda=1.2500000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.771527792790e+02 lambda=5.3912931685137378e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.150137639707e+02 lambda=5.3912931685137376e-04 > Line search: Cubically determined step, current gnorm 1.144964484571e+02 lambda=5.3912931685137380e-05 > 32 SNES Function norm 1.144964484571e+02 > 0 KSP Residual norm 3.859510930996e+01 > 1 KSP Residual norm 8.069118044382e-13 > Line search: gnorm after quadratic fit 1.106329930525e+04 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.155884463041e+03 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 5.933963819094e+02 lambda=2.5000000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.849629797377e+02 lambda=9.7744286136270241e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.150857687050e+02 lambda=9.7744286136270254e-04 > Line search: Cubically determined step, current gnorm 1.144922906340e+02 lambda=9.7744286136270254e-05 > 33 SNES Function norm 1.144922906340e+02 > 0 KSP Residual norm 4.952038022394e+01 > 1 KSP Residual norm 7.460263245424e-13 > Line search: gnorm after quadratic fit 3.005091127220e+04 > Line search: Cubic step no good, shrinking lambda, current gnorm 5.229308416025e+03 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.138600794682e+03 lambda=2.5000000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.390856262238e+02 lambda=1.2500000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.394997214983e+02 lambda=4.4582997750629580e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.146836358799e+02 lambda=4.4582997750629581e-04 > Line search: Cubically determined step, current gnorm 1.144895966587e+02 lambda=4.7644082443915877e-05 > 34 SNES Function norm 1.144895966587e+02 > 0 KSP Residual norm 1.146914786457e+02 > 1 KSP Residual norm 4.791627042400e-12 > Line search: gnorm after quadratic fit 2.601294145944e+05 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.324148513778e+04 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 5.247478406023e+03 lambda=2.5000000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.200340900661e+03 lambda=1.2500000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.696223112300e+02 lambda=6.1514413845115794e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.342365431983e+02 lambda=1.7502929694284564e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.146686063035e+02 lambda=1.7502929694284566e-04 > Line search: Cubically determined step, current gnorm 1.144895868489e+02 lambda=1.7502929694284566e-05 > 35 SNES Function norm 1.144895868489e+02 > 0 KSP Residual norm 6.311017209658e+01 > 1 KSP Residual norm 8.384445939117e-13 > Line search: gnorm after quadratic fit 5.781533400572e+04 > Line search: Cubic step no good, shrinking lambda, current gnorm 9.419557746031e+03 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.886081770030e+03 lambda=2.5000000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 4.945810143740e+02 lambda=1.2500000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.767820854837e+02 lambda=5.3859001959289735e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.150034040559e+02 lambda=5.3859001959289732e-04 > Line search: Cubically determined step, current gnorm 1.144891501665e+02 lambda=5.3859001959289732e-05 > 36 SNES Function norm 1.144891501665e+02 > 0 KSP Residual norm 3.880748384332e+01 > 1 KSP Residual norm 6.400339290453e-13 > Line search: gnorm after quadratic fit 1.122504184426e+04 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.180728237366e+03 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 5.987870621566e+02 lambda=2.5000000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.863711604331e+02 lambda=9.8150771384688824e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.150916783781e+02 lambda=9.8150771384688824e-04 > Line search: Cubically determined step, current gnorm 1.144850837411e+02 lambda=9.8150771384688832e-05 > 37 SNES Function norm 1.144850837411e+02 > 0 KSP Residual norm 4.811537498557e+01 > 1 KSP Residual norm 9.738167670242e-13 > Line search: gnorm after quadratic fit 2.784098355218e+04 > Line search: Cubic step no good, shrinking lambda, current gnorm 4.885118868254e+03 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.074843354348e+03 lambda=2.5000000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.255202820836e+02 lambda=1.2500000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.365202996130e+02 lambda=4.3204204582016374e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.146504919412e+02 lambda=4.3204204582016374e-04 > Line search: Cubically determined step, current gnorm 1.144822306241e+02 lambda=5.0376546850227848e-05 > 38 SNES Function norm 1.144822306241e+02 > 0 KSP Residual norm 1.120914002482e+02 > 1 KSP Residual norm 5.452125292284e-12 > Line search: gnorm after quadratic fit 2.427186680567e+05 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.112196656857e+04 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 4.967397366072e+03 lambda=2.5000000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.149551659770e+03 lambda=1.2500000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.529630886791e+02 lambda=6.0885216927030559e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.315267519231e+02 lambda=1.6656233536183130e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.146353659250e+02 lambda=1.6656233536183130e-04 > Line search: Cubically determined step, current gnorm 1.144820487391e+02 lambda=1.6656233536183130e-05 > 39 SNES Function norm 1.144820487391e+02 > 0 KSP Residual norm 7.182416170980e+01 > 1 KSP Residual norm 1.292147133333e-12 > Line search: gnorm after quadratic fit 8.255331293322e+04 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.302939895170e+04 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.501228089911e+03 lambda=2.5000000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.185010378583e+02 lambda=1.2500000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.088179821424e+02 lambda=5.7489510178867142e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.168272901121e+02 lambda=9.7452649444612811e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144951972300e+02 lambda=9.7452649444612822e-05 > Line search: Cubically determined step, current gnorm 1.144807676687e+02 lambda=2.2399506502463798e-05 > 40 SNES Function norm 1.144807676687e+02 > 0 KSP Residual norm 1.728679810285e+02 > 1 KSP Residual norm 3.878068639716e-12 > Line search: gnorm after quadratic fit 9.011020578535e+05 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.111818830011e+05 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.504789858103e+04 lambda=2.5000000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.754312133162e+03 lambda=1.2500000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.212492111975e+02 lambda=6.2500000000000003e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.199969180537e+02 lambda=2.6424184504193135e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.154794639440e+02 lambda=2.6424184504193136e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144880673342e+02 lambda=2.6424184504193136e-05 > Line search: Cubically determined step, current gnorm 1.144805461570e+02 lambda=3.8712107591125690e-06 > 41 SNES Function norm 1.144805461570e+02 > 0 KSP Residual norm 4.162780846202e+02 > 1 KSP Residual norm 1.732341544934e-11 > Line search: gnorm after quadratic fit 1.355673864369e+07 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.747523002884e+06 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.342205048417e+05 lambda=2.5000000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.425635699680e+04 lambda=1.2500000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 5.882150659178e+03 lambda=6.2500000000000003e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.259664786336e+03 lambda=3.1250000000000002e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.653670676209e+02 lambda=1.5625000000000001e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.453655830144e+02 lambda=5.8237455565260388e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.147659525018e+02 lambda=5.8237455565260393e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144827915995e+02 lambda=5.8237455565260400e-06 > Line search: Cubically determined step, current gnorm 1.144805080017e+02 lambda=6.6689295146509104e-07 > 42 SNES Function norm 1.144805080017e+02 > 0 KSP Residual norm 1.004135512581e+03 > 1 KSP Residual norm 3.867626041000e-09 > Line search: gnorm after quadratic fit 1.832578994882e+08 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.269698278878e+07 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.792476589915e+06 lambda=2.5000000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.420660371083e+05 lambda=1.2500000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 4.321686926168e+04 lambda=6.2500000000000003e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.548358078234e+03 lambda=3.1250000000000002e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.429504802276e+03 lambda=1.5625000000000001e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 4.317723385004e+02 lambda=7.8125000000000004e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.460079723095e+02 lambda=2.5078917343692407e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.147908977725e+02 lambda=2.5078917343692408e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144833604238e+02 lambda=2.5078917343692412e-06 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144805106824e+02 lambda=2.5078917343692411e-07 > Line search: Cubically determined step, current gnorm 1.144805014337e+02 lambda=1.1468707119027746e-07 > 43 SNES Function norm 1.144805014337e+02 > 0 KSP Residual norm 2.418614573592e+03 > 1 KSP Residual norm 6.085078742847e-10 > Line search: gnorm after quadratic fit 2.598476259775e+09 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.262759415873e+08 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 4.116845970403e+07 lambda=2.5000000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 5.250465130250e+06 lambda=1.2500000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.863493884574e+05 lambda=6.2500000000000003e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 9.501468163771e+04 lambda=3.1250000000000002e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.482658980483e+04 lambda=1.5625000000000001e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.802395557883e+03 lambda=7.8125000000000004e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.788149582374e+02 lambda=3.9062500000000002e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.248828337038e+02 lambda=1.8333058767960295e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.186285836222e+02 lambda=3.7550993478654105e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.145209710139e+02 lambda=3.7550993478654107e-06 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144808670668e+02 lambda=3.7550993478654111e-07 > Line search: Cubically determined step, current gnorm 1.144805012252e+02 lambda=3.7550993478654114e-08 > 44 SNES Function norm 1.144805012252e+02 > 0 KSP Residual norm 1.432476672735e+03 > 1 KSP Residual norm 7.850524783892e-11 > Line search: gnorm after quadratic fit 5.336191593632e+08 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.625576866625e+07 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 8.181408387845e+06 lambda=2.5000000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.003310644422e+06 lambda=1.2500000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.236384273292e+05 lambda=6.2500000000000003e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.658430638069e+04 lambda=3.1250000000000002e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.977463068161e+03 lambda=1.5625000000000001e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.674238499253e+02 lambda=7.8125000000000004e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.333616820791e+02 lambda=3.3764776729281175e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.161349153752e+02 lambda=4.0497161764116874e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144966925969e+02 lambda=4.0497161764116874e-06 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144806214839e+02 lambda=4.0497161764116878e-07 > Line search: Cubically determined step, current gnorm 1.144804979966e+02 lambda=5.6339112427782378e-08 > 45 SNES Function norm 1.144804979966e+02 > 0 KSP Residual norm 3.453401579761e+03 > 1 KSP Residual norm 4.197968028126e-09 > Line search: gnorm after quadratic fit 7.554006183767e+09 > Line search: Cubic step no good, shrinking lambda, current gnorm 9.471974940372e+08 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.191613865049e+08 lambda=2.5000000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.509784334249e+07 lambda=1.2500000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.943752478560e+06 lambda=6.2500000000000003e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.597601716755e+05 lambda=3.1250000000000002e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.775572331075e+04 lambda=1.5625000000000001e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.418045407608e+03 lambda=7.8125000000000004e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.357066758731e+03 lambda=3.9062500000000002e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.859267839080e+02 lambda=1.9531250000000001e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.501494912160e+02 lambda=7.5160826909319168e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.148144926477e+02 lambda=7.5160826909319171e-06 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144837498478e+02 lambda=7.5160826909319179e-07 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144805227746e+02 lambda=7.5160826909319182e-08 > Line search: Cubically determined step, current gnorm 1.144804974438e+02 lambda=9.6864021663644795e-09 > 46 SNES Function norm 1.144804974438e+02 > 0 KSP Residual norm 8.345139428850e+03 > 1 KSP Residual norm 1.027819754739e-09 > Line search: gnorm after quadratic fit 1.061319903906e+11 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.325012985379e+10 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.652236226640e+09 lambda=2.5000000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.055533971630e+08 lambda=1.2500000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.546607716763e+07 lambda=6.2500000000000003e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.134442858835e+06 lambda=3.1250000000000002e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.839168570687e+05 lambda=1.5625000000000001e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 4.830568178626e+04 lambda=7.8125000000000004e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.201776786081e+03 lambda=3.9062500000000002e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.540520468013e+03 lambda=1.9531250000000001e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 4.573504890506e+02 lambda=9.7656250000000005e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.516203908013e+02 lambda=3.2703670177372021e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.148480075676e+02 lambda=3.2703670177372022e-06 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144841475328e+02 lambda=3.2703670177372023e-07 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144805305720e+02 lambda=3.2703670177372021e-08 > Line search: Cubically determined step, current gnorm 1.144804974367e+02 lambda=3.2703670177372025e-09 > 47 SNES Function norm 1.144804974367e+02 > 0 KSP Residual norm 4.668983500382e+03 > 1 KSP Residual norm 1.398997665317e-09 > Line search: gnorm after quadratic fit 1.865309565532e+10 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.336975299727e+09 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.934905088739e+08 lambda=2.5000000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.704520478641e+07 lambda=1.2500000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 4.728477809448e+06 lambda=6.2500000000000003e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.193001670096e+05 lambda=3.1250000000000002e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 8.610673238239e+04 lambda=1.5625000000000001e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.354711683605e+04 lambda=7.8125000000000004e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.589557246433e+03 lambda=3.9062500000000002e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.367851970709e+02 lambda=1.9531250000000001e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.136930269795e+02 lambda=9.0316845802227864e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.172186635069e+02 lambda=1.5831613287181393e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.145074017254e+02 lambda=1.5831613287181394e-06 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144807499816e+02 lambda=1.5831613287181396e-07 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144804983345e+02 lambda=1.5831613287181397e-08 > Line search: Cubically determined step, current gnorm 1.144804971346e+02 lambda=5.2932921109871310e-09 > 48 SNES Function norm 1.144804971346e+02 > 0 KSP Residual norm 1.132678078317e+04 > 1 KSP Residual norm 2.477518733314e-10 > Line search: gnorm after quadratic fit 2.654659022365e+11 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.315296223725e+10 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 4.136635677074e+09 lambda=2.5000000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 5.152507060235e+08 lambda=1.2500000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.397060094478e+07 lambda=6.2500000000000003e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.898362012287e+06 lambda=3.1250000000000002e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 9.685179520906e+05 lambda=1.5625000000000001e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.194040779842e+05 lambda=7.8125000000000004e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.606415730227e+04 lambda=3.9062500000000002e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.902698091972e+03 lambda=1.9531250000000001e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.521549384652e+02 lambda=9.7656250000000005e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.288999778994e+02 lambda=4.1899746703195281e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.157880829786e+02 lambda=4.5470218451893824e-06 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144935741206e+02 lambda=4.5470218451893828e-07 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144806232638e+02 lambda=4.5470218451893831e-08 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144804979250e+02 lambda=4.5470218451893835e-09 > Line search: Cubically determined step, current gnorm 1.144804970825e+02 lambda=9.0293679903918216e-10 > 49 SNES Function norm 1.144804970825e+02 > 0 KSP Residual norm 2.712544829144e+04 > 1 KSP Residual norm 4.949246309677e-09 > Line search: gnorm after quadratic fit 3.650846005745e+12 > Line search: Cubic step no good, shrinking lambda, current gnorm 4.565321055911e+11 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 5.711080201118e+10 lambda=2.5000000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.150022242308e+09 lambda=1.2500000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 8.965954117985e+08 lambda=6.2500000000000003e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.128096393645e+08 lambda=3.1250000000000002e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.429702091584e+07 lambda=1.5625000000000001e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.841819946536e+06 lambda=7.8125000000000004e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.465032956946e+05 lambda=3.9062500000000002e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.594210253794e+04 lambda=1.9531250000000001e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.141110278944e+03 lambda=9.7656250000000005e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.306952279045e+03 lambda=4.8828125000000003e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.754164864338e+02 lambda=2.4414062500000001e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.476861367158e+02 lambda=9.2451761406722810e-06 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.147929263780e+02 lambda=9.2451761406722810e-07 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144836022952e+02 lambda=9.2451761406722821e-08 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144805271860e+02 lambda=9.2451761406722831e-09 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144804972895e+02 lambda=9.2451761406722839e-10 > Line search: Cubically determined step, current gnorm 1.144804970737e+02 lambda=1.5633616333063305e-10 > 50 SNES Function norm 1.144804970737e+02 > 0 SNES Function norm 2.308693894796e+03 > 0 KSP Residual norm 8.981999720532e+00 > 1 KSP Residual norm 2.363170936183e-13 > Line search: Using full step: fnorm 2.308693894796e+03 gnorm 7.571661187318e+02 > 1 SNES Function norm 7.571661187318e+02 > 0 KSP Residual norm 2.149614048903e+00 > 1 KSP Residual norm 9.511247057888e-13 > Line search: Using full step: fnorm 7.571661187318e+02 gnorm 4.450081004997e+02 > 2 SNES Function norm 4.450081004997e+02 > 0 KSP Residual norm 1.706469075123e+01 > 1 KSP Residual norm 5.803815175472e-13 > Line search: gnorm after quadratic fit 1.510518198899e+03 > Line search: Cubic step no good, shrinking lambda, current gnorm 5.850796532980e+02 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 4.515983139755e+02 lambda=2.0602556887689423e-02 > Line search: Cubically determined step, current gnorm 4.434800867235e+02 lambda=8.2396279492937211e-03 > 3 SNES Function norm 4.434800867235e+02 > 0 KSP Residual norm 3.208587171626e+00 > 1 KSP Residual norm 1.099072610659e-13 > Line search: gnorm after quadratic fit 4.080637194736e+02 > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > 4 SNES Function norm 4.080637194736e+02 > 0 KSP Residual norm 8.136557176540e+00 > 1 KSP Residual norm 8.800137844173e-13 > Line search: gnorm after quadratic fit 5.261656549654e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 4.131114070934e+02 lambda=5.0000000000000003e-02 > Line search: Cubically determined step, current gnorm 4.031614746044e+02 lambda=2.4674842039461482e-02 > 5 SNES Function norm 4.031614746044e+02 > 0 KSP Residual norm 7.609918907567e+00 > 1 KSP Residual norm 1.613159932655e-13 > Line search: gnorm after quadratic fit 5.353908064984e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 4.110480554132e+02 lambda=5.0000000000000003e-02 > Line search: Cubically determined step, current gnorm 3.991168240716e+02 lambda=2.3079500036735322e-02 > 6 SNES Function norm 3.991168240716e+02 > 0 KSP Residual norm 3.800845472041e+00 > 1 KSP Residual norm 4.841682188278e-13 > Line search: gnorm after quadratic fit 3.787886582952e+02 > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > 7 SNES Function norm 3.787886582952e+02 > 0 KSP Residual norm 1.892621919219e+00 > 1 KSP Residual norm 3.576655371800e-12 > Line search: gnorm after quadratic fit 3.440181918909e+02 > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > 8 SNES Function norm 3.440181918909e+02 > 0 KSP Residual norm 3.559759789147e+00 > 1 KSP Residual norm 8.347521826622e-13 > Line search: gnorm after quadratic fit 3.287993515195e+02 > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > 9 SNES Function norm 3.287993515195e+02 > 0 KSP Residual norm 1.825073540507e+00 > 1 KSP Residual norm 8.352745008123e-14 > Line search: Using full step: fnorm 3.287993515195e+02 gnorm 2.710650507416e+02 > 10 SNES Function norm 2.710650507416e+02 > 0 KSP Residual norm 7.568432945608e-01 > 1 KSP Residual norm 2.780715252274e-14 > Line search: Using full step: fnorm 2.710650507416e+02 gnorm 1.513359047342e+02 > 11 SNES Function norm 1.513359047342e+02 > 0 KSP Residual norm 9.387460484575e+00 > 1 KSP Residual norm 7.091233040676e-13 > Line search: gnorm after quadratic fit 3.998857979851e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.060972049714e+02 lambda=5.0000000000000003e-02 > Line search: Cubically determined step, current gnorm 1.512140169420e+02 lambda=5.4338709720680610e-03 > 12 SNES Function norm 1.512140169420e+02 > 0 KSP Residual norm 4.399424360499e+00 > 1 KSP Residual norm 1.614362118182e-13 > Line search: gnorm after quadratic fit 1.913552832643e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.559719302467e+02 lambda=5.0000000000000003e-02 > Line search: Cubically determined step, current gnorm 1.499985374733e+02 lambda=1.7102027220313589e-02 > 13 SNES Function norm 1.499985374733e+02 > 0 KSP Residual norm 3.740397849742e+00 > 1 KSP Residual norm 8.986775577006e-13 > Line search: gnorm after quadratic fit 1.764118876632e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.522381536119e+02 lambda=4.8196830215713270e-02 > Line search: Cubically determined step, current gnorm 1.486175880390e+02 lambda=1.8881300948189364e-02 > 14 SNES Function norm 1.486175880390e+02 > 0 KSP Residual norm 6.067973818528e+00 > 1 KSP Residual norm 4.527845229549e-13 > Line search: gnorm after quadratic fit 2.514021299115e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.679972156573e+02 lambda=5.0000000000000003e-02 > Line search: Cubically determined step, current gnorm 1.481015724304e+02 lambda=9.0116621678703428e-03 > 15 SNES Function norm 1.481015724304e+02 > 0 KSP Residual norm 6.108754994263e+00 > 1 KSP Residual norm 2.557635976440e-13 > Line search: gnorm after quadratic fit 2.458081150104e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.681837029397e+02 lambda=5.0000000000000003e-02 > Line search: Cubically determined step, current gnorm 1.476148340442e+02 lambda=7.9580911933571953e-03 > 16 SNES Function norm 1.476148340442e+02 > 0 KSP Residual norm 7.914946163932e+00 > 1 KSP Residual norm 1.512066885699e-13 > Line search: gnorm after quadratic fit 3.458938604598e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.883018868359e+02 lambda=5.0000000000000003e-02 > Line search: Cubically determined step, current gnorm 1.474286108114e+02 lambda=6.7262521208543979e-03 > 17 SNES Function norm 1.474286108114e+02 > 0 KSP Residual norm 5.285449532689e+00 > 1 KSP Residual norm 6.693733977456e-12 > Line search: gnorm after quadratic fit 2.170263102661e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.607560548008e+02 lambda=5.0000000000000003e-02 > Line search: Cubically determined step, current gnorm 1.467785507822e+02 lambda=9.9244383205188240e-03 > 18 SNES Function norm 1.467785507822e+02 > 0 KSP Residual norm 8.124903695635e+00 > 1 KSP Residual norm 2.322439601127e-11 > Line search: gnorm after quadratic fit 3.589716592364e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.907315184877e+02 lambda=5.0000000000000003e-02 > Line search: Cubically determined step, current gnorm 1.466341888638e+02 lambda=6.5538271222582893e-03 > 19 SNES Function norm 1.466341888638e+02 > 0 KSP Residual norm 5.253550718343e+00 > 1 KSP Residual norm 1.575657996883e-12 > Line search: gnorm after quadratic fit 2.155795776725e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.598564001687e+02 lambda=5.0000000000000003e-02 > Line search: Cubically determined step, current gnorm 1.459869404602e+02 lambda=9.9195822632931301e-03 > 20 SNES Function norm 1.459869404602e+02 > 0 KSP Residual norm 8.405987790193e+00 > 1 KSP Residual norm 2.046159481178e-13 > Line search: gnorm after quadratic fit 3.767908298426e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.941885062002e+02 lambda=5.0000000000000003e-02 > Line search: Cubically determined step, current gnorm 1.458995232755e+02 lambda=6.4359684554015136e-03 > 21 SNES Function norm 1.458995232755e+02 > 0 KSP Residual norm 5.036348246593e+00 > 1 KSP Residual norm 3.645081669075e-13 > Line search: gnorm after quadratic fit 2.083222977519e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.575737508694e+02 lambda=5.0000000000000003e-02 > Line search: Cubically determined step, current gnorm 1.452039802458e+02 lambda=1.0554092389542354e-02 > 22 SNES Function norm 1.452039802458e+02 > 0 KSP Residual norm 8.562292355998e+00 > 1 KSP Residual norm 3.256332645483e-13 > Line search: gnorm after quadratic fit 3.869470823355e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.959483128249e+02 lambda=5.0000000000000003e-02 > Line search: Cubically determined step, current gnorm 1.451523830598e+02 lambda=6.3780526507799607e-03 > 23 SNES Function norm 1.451523830598e+02 > 0 KSP Residual norm 4.919667503862e+00 > 1 KSP Residual norm 4.823931177115e-13 > Line search: gnorm after quadratic fit 2.042891039525e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.560623102934e+02 lambda=5.0000000000000003e-02 > Line search: Cubically determined step, current gnorm 1.444331916523e+02 lambda=1.0890355421223689e-02 > 24 SNES Function norm 1.444331916523e+02 > 0 KSP Residual norm 8.727282395369e+00 > 1 KSP Residual norm 7.090683582186e-13 > Line search: gnorm after quadratic fit 3.977929422821e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.978556223200e+02 lambda=5.0000000000000003e-02 > Line search: Cubically determined step, current gnorm 1.444215965394e+02 lambda=6.3477766966048947e-03 > 25 SNES Function norm 1.444215965394e+02 > 0 KSP Residual norm 4.759732971179e+00 > 1 KSP Residual norm 7.539889498211e-13 > Line search: gnorm after quadratic fit 1.990589649135e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.542648241555e+02 lambda=5.0000000000000003e-02 > Line search: Cubically determined step, current gnorm 1.436629416941e+02 lambda=1.1434720389464151e-02 > 26 SNES Function norm 1.436629416941e+02 > 0 KSP Residual norm 8.844861828477e+00 > 1 KSP Residual norm 4.372001279689e-13 > Line search: gnorm after quadratic fit 4.055598972133e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.990820671396e+02 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.436827663113e+02 lambda=6.3302081701296859e-03 > Line search: Cubically determined step, current gnorm 1.434397789472e+02 lambda=3.1285674619640730e-03 > 27 SNES Function norm 1.434397789472e+02 > 0 KSP Residual norm 2.168630760128e+01 > 1 KSP Residual norm 3.975838928402e-13 > Line search: gnorm after quadratic fit 1.655681371309e+03 > Line search: Cubic step no good, shrinking lambda, current gnorm 4.972331169594e+02 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.804118272840e+02 lambda=1.6710557456633125e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.435928635079e+02 lambda=1.6710557456633126e-03 > Line search: Cubically determined step, current gnorm 1.434032742903e+02 lambda=5.1357350159978810e-04 > 28 SNES Function norm 1.434032742903e+02 > 0 KSP Residual norm 5.259508821923e+01 > 1 KSP Residual norm 1.358381204928e-11 > Line search: gnorm after quadratic fit 1.908330224731e+04 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.431279702545e+03 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 8.060945045253e+02 lambda=2.5000000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.791318323447e+02 lambda=1.2124172979783788e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.491140019897e+02 lambda=2.6952165802905347e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434246250245e+02 lambda=2.6952165802905350e-04 > Line search: Cubically determined step, current gnorm 1.433970449422e+02 lambda=8.6980371578986910e-05 > 29 SNES Function norm 1.433970449422e+02 > 0 KSP Residual norm 1.326287161615e+02 > 1 KSP Residual norm 5.692176796134e-12 > Line search: gnorm after quadratic fit 2.077891749832e+05 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.654187989332e+04 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 4.213029457851e+03 lambda=2.5000000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.001385334742e+03 lambda=1.2500000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.323976827250e+02 lambda=5.9607661619885998e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.489839529892e+02 lambda=1.0476257410701045e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434396736634e+02 lambda=1.0476257410701046e-04 > Line search: Cubically determined step, current gnorm 1.433960671821e+02 lambda=1.3664867646895530e-05 > 30 SNES Function norm 1.433960671821e+02 > 0 KSP Residual norm 3.320710360189e+02 > 1 KSP Residual norm 1.365660123102e-11 > Line search: gnorm after quadratic fit 3.597335441013e+06 > Line search: Cubic step no good, shrinking lambda, current gnorm 4.714766420450e+05 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.566809766217e+04 lambda=2.5000000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.038660363150e+04 lambda=1.2500000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.026997416957e+03 lambda=6.2500000000000003e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 5.382653551072e+02 lambda=3.1250000000000002e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.071747386385e+02 lambda=1.3384948046761360e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.439693866777e+02 lambda=1.3384948046761360e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434000505249e+02 lambda=1.3384948046761361e-05 > Line search: Cubically determined step, current gnorm 1.433959111179e+02 lambda=2.1771867000079373e-06 > 31 SNES Function norm 1.433959111179e+02 > 0 KSP Residual norm 8.385024273664e+02 > 1 KSP Residual norm 2.688330817732e-11 > Line search: gnorm after quadratic fit 5.487352481970e+07 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.776642694838e+06 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 8.310551423141e+05 lambda=2.5000000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.023322644608e+05 lambda=1.2500000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.368662233379e+04 lambda=6.2500000000000003e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.472194884015e+03 lambda=3.1250000000000002e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.718801059897e+02 lambda=1.5625000000000001e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.274234972424e+02 lambda=6.3064412238487922e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.442194384053e+02 lambda=6.3064412238487925e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434033578642e+02 lambda=6.3064412238487927e-06 > Line search: Cubically determined step, current gnorm 1.433959042208e+02 lambda=6.3064412238487929e-07 > 32 SNES Function norm 1.433959042208e+02 > 0 KSP Residual norm 5.310191626867e+02 > 1 KSP Residual norm 2.270033897601e-10 > Line search: gnorm after quadratic fit 1.447633783740e+07 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.859761774309e+06 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.472992503503e+05 lambda=2.5000000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.557594026810e+04 lambda=1.2500000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 5.969012939380e+03 lambda=6.2500000000000003e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.269212161982e+03 lambda=3.1250000000000002e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.859005100842e+02 lambda=1.5625000000000001e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.695095262046e+02 lambda=5.4509037994531233e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.436389958907e+02 lambda=5.4509037994531237e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433976258223e+02 lambda=5.4509037994531242e-06 > Line search: Cubically determined step, current gnorm 1.433958431980e+02 lambda=8.5124820362933632e-07 > 33 SNES Function norm 1.433958431980e+02 > 0 KSP Residual norm 1.341142541825e+03 > 1 KSP Residual norm 4.194815344365e-11 > Line search: gnorm after quadratic fit 2.256410317099e+08 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.797696259877e+07 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.447237377751e+06 lambda=2.5000000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 4.221898175722e+05 lambda=1.2500000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 5.260244723327e+04 lambda=6.2500000000000003e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.539148524881e+03 lambda=3.1250000000000002e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.558034531173e+03 lambda=1.5625000000000001e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 4.788188892302e+02 lambda=7.8125000000000004e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.753621043454e+02 lambda=2.4427125599600652e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.437122397600e+02 lambda=2.4427125599600654e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433986985128e+02 lambda=2.4427125599600655e-06 > Line search: Cubically determined step, current gnorm 1.433958402293e+02 lambda=2.4427125599600656e-07 > 34 SNES Function norm 1.433958402293e+02 > 0 KSP Residual norm 8.620962950418e+02 > 1 KSP Residual norm 4.517777375659e-11 > Line search: gnorm after quadratic fit 6.134442313460e+07 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.790495969255e+06 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.008365220843e+06 lambda=2.5000000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.364572513478e+05 lambda=1.2500000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.037891335918e+04 lambda=6.2500000000000003e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.640571521199e+03 lambda=3.1250000000000002e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 8.472549649319e+02 lambda=1.5625000000000001e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.906041216274e+02 lambda=7.6348458761785112e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.504925859329e+02 lambda=1.7740973415567094e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434632637071e+02 lambda=1.7740973415567094e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433962847027e+02 lambda=1.7740973415567095e-06 > Line search: Cubically determined step, current gnorm 1.433958170795e+02 lambda=3.2293255704969003e-07 > 35 SNES Function norm 1.433958170795e+02 > 0 KSP Residual norm 2.177497039945e+03 > 1 KSP Residual norm 8.546235181505e-11 > Line search: gnorm after quadratic fit 9.689178330938e+08 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.204850731541e+08 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.491460480376e+07 lambda=2.5000000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.833699292784e+06 lambda=1.2500000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.246639021599e+05 lambda=6.2500000000000003e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.860166571872e+04 lambda=3.1250000000000002e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 4.484329051490e+03 lambda=1.5625000000000001e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.050411687443e+03 lambda=7.8125000000000004e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.488366972009e+02 lambda=3.7767265396089055e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.508326035050e+02 lambda=7.2725649346261757e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434696063559e+02 lambda=7.2725649346261764e-06 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433964618996e+02 lambda=7.2725649346261768e-07 > Line search: Cubically determined step, current gnorm 1.433958141405e+02 lambda=7.2725649346261771e-08 > 36 SNES Function norm 1.433958141405e+02 > 0 KSP Residual norm 2.164813477994e+03 > 1 KSP Residual norm 1.148881458292e-10 > Line search: gnorm after quadratic fit 9.626940870744e+08 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.210459267934e+08 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.531855101756e+07 lambda=2.5000000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.966826097072e+06 lambda=1.2500000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.611808255272e+05 lambda=6.2500000000000003e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.746062783262e+04 lambda=3.1250000000000002e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.252259871244e+03 lambda=1.5625000000000001e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.319447372021e+03 lambda=7.8125000000000004e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.963055448218e+02 lambda=3.9062500000000002e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.719034797105e+02 lambda=1.3935000445038475e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.436664111092e+02 lambda=1.3935000445038476e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433983336239e+02 lambda=1.3935000445038476e-06 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958213497e+02 lambda=1.3935000445038476e-07 > Line search: Cubically determined step, current gnorm 1.433958104705e+02 lambda=5.1202466521517630e-08 > 37 SNES Function norm 1.433958104705e+02 > 0 KSP Residual norm 5.470482746849e+03 > 1 KSP Residual norm 2.077456833170e-10 > Line search: gnorm after quadratic fit 1.541335606193e+10 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.922526157954e+09 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.393079394383e+08 lambda=2.5000000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.967573549050e+07 lambda=1.2500000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.657319925168e+06 lambda=6.2500000000000003e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 4.479516204895e+05 lambda=3.1250000000000002e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 5.573399122917e+04 lambda=1.5625000000000001e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.931177424479e+03 lambda=7.8125000000000004e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.619710606187e+03 lambda=3.9062500000000002e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 4.924551713717e+02 lambda=1.9531250000000001e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.786095404459e+02 lambda=6.2808469554243522e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.437467476469e+02 lambda=6.2808469554243527e-06 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433992463439e+02 lambda=6.2808469554243527e-07 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958367271e+02 lambda=6.2808469554243525e-08 > Line search: Cubically determined step, current gnorm 1.433958098948e+02 lambda=8.0208105170108588e-09 > 38 SNES Function norm 1.433958098948e+02 > 0 KSP Residual norm 1.380568582849e+04 > 1 KSP Residual norm 3.830866223513e-10 > Line search: gnorm after quadratic fit 2.484973518314e+11 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.108953896984e+10 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.893104137528e+09 lambda=2.5000000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 4.884003910853e+08 lambda=1.2500000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.150765563542e+07 lambda=6.2500000000000003e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.811161146103e+06 lambda=3.1250000000000002e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.011017986781e+06 lambda=1.5625000000000001e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.368084343451e+05 lambda=7.8125000000000004e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.042876665700e+04 lambda=3.9062500000000002e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.648735196752e+03 lambda=1.9531250000000001e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 8.489051252413e+02 lambda=9.7656250000000005e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.910677756717e+02 lambda=4.7728537787817724e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.505452645186e+02 lambda=1.1099980464343249e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434658984864e+02 lambda=1.1099980464343249e-06 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433964956476e+02 lambda=1.1099980464343249e-07 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958153212e+02 lambda=1.1099980464343250e-08 > Line search: Cubically determined step, current gnorm 1.433958098048e+02 lambda=1.2587012037197021e-09 > 39 SNES Function norm 1.433958098048e+02 > 0 KSP Residual norm 3.492284741552e+04 > 1 KSP Residual norm 2.459788921244e-09 > Line search: gnorm after quadratic fit 4.017424324975e+12 > Line search: Cubic step no good, shrinking lambda, current gnorm 5.020053801097e+11 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.270768402853e+10 lambda=2.5000000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.827801904036e+09 lambda=1.2500000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 9.758550488105e+08 lambda=6.2500000000000003e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.213492627852e+08 lambda=3.1250000000000002e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.502191365805e+07 lambda=1.5625000000000001e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.846947104704e+06 lambda=7.8125000000000004e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.262850216093e+05 lambda=3.9062500000000002e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.879926646684e+04 lambda=1.9531250000000001e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 4.510203332079e+03 lambda=9.7656250000000005e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.055028679619e+03 lambda=4.8828125000000003e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.503903269554e+02 lambda=2.3633949212111800e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.510245991472e+02 lambda=4.5897967908360529e-06 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434724062782e+02 lambda=4.5897967908360533e-07 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433965706606e+02 lambda=4.5897967908360533e-08 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958168196e+02 lambda=4.5897967908360538e-09 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958098155e+02 lambda=4.5897967908360540e-10 > Line search: Cubically determined step, current gnorm 1.433958097906e+02 lambda=1.9745369723997599e-10 > 40 SNES Function norm 1.433958097906e+02 > 0 KSP Residual norm 8.722495521587e+04 > 1 KSP Residual norm 3.742695919275e-09 > Line search: gnorm after quadratic fit 6.262538457180e+13 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.829256308992e+12 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 9.789282877890e+11 lambda=2.5000000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.224340679566e+11 lambda=1.2500000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.532137613500e+10 lambda=6.2500000000000003e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.919506047737e+09 lambda=3.1250000000000002e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.410488718338e+08 lambda=1.5625000000000001e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.042211373104e+07 lambda=7.8125000000000004e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.881986305609e+06 lambda=3.9062500000000002e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 5.080857001861e+05 lambda=1.9531250000000001e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.054449734307e+04 lambda=9.7656250000000005e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.109051581397e+04 lambda=4.8828125000000003e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.144985497099e+03 lambda=2.4414062500000001e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 5.617627947761e+02 lambda=1.2207031250000001e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.132828960986e+02 lambda=5.3137869181552773e-06 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.440403409760e+02 lambda=5.3137869181552777e-07 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434022226216e+02 lambda=5.3137869181552781e-08 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958732177e+02 lambda=5.3137869181552781e-09 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958103569e+02 lambda=5.3137869181552779e-10 > Line search: Cubically determined step, current gnorm 1.433958097894e+02 lambda=5.3137869181552781e-11 > 41 SNES Function norm 1.433958097894e+02 > 0 KSP Residual norm 6.453169081212e+04 > 1 KSP Residual norm 2.762540688686e-09 > Line search: gnorm after quadratic fit 2.535166112592e+13 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.168366990040e+12 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.958985371462e+11 lambda=2.5000000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 4.945064622488e+10 lambda=1.2500000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.172244865713e+09 lambda=6.2500000000000003e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.693002384290e+08 lambda=3.1250000000000002e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 9.562568994785e+07 lambda=1.5625000000000001e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.182957296890e+07 lambda=7.8125000000000004e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.453260254263e+06 lambda=3.9062500000000002e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.781984147743e+05 lambda=1.9531250000000001e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.294934468515e+04 lambda=9.7656250000000005e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.740461720782e+03 lambda=4.8828125000000003e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 9.162621855154e+02 lambda=2.4414062500000001e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.042417294890e+02 lambda=1.1290474210136388e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.458920680477e+02 lambda=1.4201366604660443e-06 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434208620254e+02 lambda=1.4201366604660444e-07 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433960586269e+02 lambda=1.4201366604660445e-08 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958120934e+02 lambda=1.4201366604660445e-09 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958097940e+02 lambda=1.4201366604660446e-10 > Line search: Cubically determined step, current gnorm 1.433958097852e+02 lambda=5.7981795207229486e-11 > 42 SNES Function norm 1.433958097852e+02 > 0 KSP Residual norm 1.596625793747e+05 > 1 KSP Residual norm 6.465899717071e-09 > Line search: gnorm after quadratic fit 3.840699863976e+14 > Line search: Cubic step no good, shrinking lambda, current gnorm 4.801237514773e+13 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.002454410823e+12 lambda=2.5000000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.505340831651e+11 lambda=1.2500000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 9.387378188418e+10 lambda=6.2500000000000003e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.174857842415e+10 lambda=3.1250000000000002e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.472211181784e+09 lambda=1.5625000000000001e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.849608933788e+08 lambda=7.8125000000000004e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.336592011613e+07 lambda=3.9062500000000002e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.988079805895e+06 lambda=1.9531250000000001e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.930858080425e+05 lambda=9.7656250000000005e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 5.521190722497e+04 lambda=4.8828125000000003e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 8.872153015323e+03 lambda=2.4414062500000001e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.772337662956e+03 lambda=1.2207031250000001e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 4.879470852054e+02 lambda=6.1035156250000003e-06 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.942774855488e+02 lambda=2.4957912736226801e-06 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.438719078958e+02 lambda=2.4957912736226800e-07 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434005516391e+02 lambda=2.4957912736226800e-08 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958568732e+02 lambda=2.4957912736226803e-09 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958102244e+02 lambda=2.4957912736226804e-10 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958097865e+02 lambda=2.4957912736226805e-11 > Line search: Cubically determined step, current gnorm 1.433958097846e+02 lambda=9.2900433293108317e-12 > 43 SNES Function norm 1.433958097846e+02 > 0 KSP Residual norm 4.230869747157e+05 > 1 KSP Residual norm 2.238707423027e-08 > Line search: gnorm after quadratic fit 7.145700515048e+15 > Line search: Cubic step no good, shrinking lambda, current gnorm 8.931871281700e+14 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.116420341041e+14 lambda=2.5000000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.395366610168e+13 lambda=1.2500000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.743811756566e+12 lambda=6.2500000000000003e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.178776103292e+11 lambda=3.1250000000000002e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.721012032848e+10 lambda=1.5625000000000001e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.395186924428e+09 lambda=7.8125000000000004e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 4.229125978585e+08 lambda=3.9062500000000002e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 5.250971135953e+07 lambda=1.9531250000000001e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.483856203094e+06 lambda=9.7656250000000005e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.950671355228e+05 lambda=4.8828125000000003e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 9.795408218555e+04 lambda=2.4414062500000001e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.315025696280e+04 lambda=1.2207031250000001e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.395961070555e+03 lambda=6.1035156250000003e-06 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.565070307576e+02 lambda=3.0517578125000002e-06 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.228949713871e+02 lambda=1.2154989071946628e-06 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.441831998014e+02 lambda=1.2154989071946629e-07 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434037055996e+02 lambda=1.2154989071946630e-08 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958886074e+02 lambda=1.2154989071946630e-09 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958105564e+02 lambda=1.2154989071946630e-10 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958097907e+02 lambda=1.2154989071946631e-11 > Line search: Cubically determined step, current gnorm 1.433958097845e+02 lambda=1.3559489351735629e-12 > 44 SNES Function norm 1.433958097845e+02 > 0 KSP Residual norm 1.017589039922e+06 > 1 KSP Residual norm 5.483283808994e-08 > Line search: gnorm after quadratic fit 9.942386816509e+16 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.242813073279e+16 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.553553149772e+15 lambda=2.5000000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.942033483320e+14 lambda=1.2500000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.427772097758e+13 lambda=6.2500000000000003e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.035291372732e+12 lambda=3.1250000000000002e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.795558047824e+11 lambda=1.5625000000000001e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 4.748073147307e+10 lambda=7.8125000000000004e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 5.944235240368e+09 lambda=3.9062500000000002e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.453550734860e+08 lambda=1.9531250000000001e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 9.377045707707e+07 lambda=9.7656250000000005e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.188119937132e+07 lambda=4.8828125000000003e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.529730353136e+06 lambda=2.4414062500000001e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.044646611329e+05 lambda=1.2207031250000001e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.974477616118e+04 lambda=6.1035156250000003e-06 > Line search: Cubic step no good, shrinking lambda, current gnorm 5.087923877078e+03 lambda=3.0517578125000002e-06 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.112257173311e+03 lambda=1.5258789062500001e-06 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.536190077033e+02 lambda=7.6293945312500004e-07 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.622567424729e+02 lambda=2.4244966960965791e-07 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.435780438142e+02 lambda=2.4244966960965793e-08 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433976282603e+02 lambda=2.4244966960965796e-09 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958279382e+02 lambda=2.4244966960965797e-10 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958099632e+02 lambda=2.4244966960965799e-11 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958097860e+02 lambda=2.4244966960965801e-12 > Line search: Cubically determined step, current gnorm 1.433958097845e+02 lambda=2.4244966960965801e-13 > 45 SNES Function norm 1.433958097845e+02 > 0 KSP Residual norm 2.206687220910e+06 > 1 KSP Residual norm 4.897651438902e-08 > Line search: gnorm after quadratic fit 1.013883843512e+18 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.267347883019e+17 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.584167551460e+16 lambda=2.5000000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.980166189110e+15 lambda=1.2500000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.475099638694e+14 lambda=6.2500000000000003e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.093604443378e+13 lambda=3.1250000000000002e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.866330988164e+12 lambda=1.5625000000000001e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 4.831230804145e+11 lambda=7.8125000000000004e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.034848618023e+10 lambda=3.9062500000000002e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.533173457427e+09 lambda=1.9531250000000001e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 9.390937545910e+08 lambda=9.7656250000000005e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.167706366282e+08 lambda=4.8828125000000003e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.445357932595e+07 lambda=2.4414062500000001e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.776833600920e+06 lambda=1.2207031250000001e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.177171496134e+05 lambda=6.1035156250000003e-06 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.775750596740e+04 lambda=3.0517578125000002e-06 > Line search: Cubic step no good, shrinking lambda, current gnorm 4.374283858049e+03 lambda=1.5258789062500001e-06 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.030949543491e+03 lambda=7.6293945312500004e-07 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.423064811256e+02 lambda=3.6673216108643130e-07 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.499924205417e+02 lambda=6.7541706529544844e-08 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434620968378e+02 lambda=6.7541706529544851e-09 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433964732224e+02 lambda=6.7541706529544853e-10 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958164087e+02 lambda=6.7541706529544856e-11 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958098496e+02 lambda=6.7541706529544860e-12 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958097850e+02 lambda=6.7541706529544869e-13 > Line search: unable to find good step length! After 24 tries > Line search: fnorm=1.4339580978447020e+02, gnorm=1.4339580978501337e+02, ynorm=2.2066872446260620e+06, minlambda=9.9999999999999998e-13, lambda=6.7541706529544869e-13, initial slope=-2.0562359199040133e+04 > 0 SNES Function norm 7.494832241120e+03 > 0 KSP Residual norm 2.096735360816e+01 > 1 KSP Residual norm 1.310027756820e-12 > Line search: gnorm after quadratic fit 6.728375857515e+03 > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > 1 SNES Function norm 6.728375857515e+03 > 0 KSP Residual norm 2.051806116405e+01 > 1 KSP Residual norm 4.624620138831e-13 > Line search: gnorm after quadratic fit 6.028616261650e+03 > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > 2 SNES Function norm 6.028616261650e+03 > 0 KSP Residual norm 2.416503160016e+01 > 1 KSP Residual norm 8.456041680630e-13 > Line search: gnorm after quadratic fit 5.407473517447e+03 > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > 3 SNES Function norm 5.407473517447e+03 > 0 KSP Residual norm 1.429873750399e+01 > 1 KSP Residual norm 2.956316145819e-13 > Line search: Using full step: fnorm 5.407473517447e+03 gnorm 1.894530516076e+03 > 4 SNES Function norm 1.894530516076e+03 > 0 KSP Residual norm 2.898580554597e+00 > 1 KSP Residual norm 6.622560162623e-14 > Line search: Using full step: fnorm 1.894530516076e+03 gnorm 1.794029421846e+03 > 5 SNES Function norm 1.794029421846e+03 > 0 KSP Residual norm 1.749678611959e+01 > 1 KSP Residual norm 8.138905825078e-12 > Line search: gnorm after quadratic fit 1.767361408940e+03 > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > 6 SNES Function norm 1.767361408940e+03 > 0 KSP Residual norm 1.094404109423e+02 > 1 KSP Residual norm 7.696691527700e-12 > Line search: gnorm after quadratic fit 3.545750923895e+04 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.153479540314e+03 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.205683629874e+03 lambda=2.5000000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.802976525485e+03 lambda=1.2441094586006883e-02 > Line search: Cubically determined step, current gnorm 1.765063299263e+03 lambda=4.9240328094708914e-03 > 7 SNES Function norm 1.765063299263e+03 > 0 KSP Residual norm 1.778095975189e+01 > 1 KSP Residual norm 2.814661813934e-12 > Line search: gnorm after quadratic fit 2.620761680117e+03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.793045753271e+03 lambda=5.0000000000000003e-02 > Line search: Cubically determined step, current gnorm 1.740299227935e+03 lambda=2.5000000000000001e-02 > 8 SNES Function norm 1.740299227935e+03 > 0 KSP Residual norm 3.284236894535e+02 > 1 KSP Residual norm 5.172103783952e-10 > Line search: gnorm after quadratic fit 2.857820523902e+05 > Line search: Cubic step no good, shrinking lambda, current gnorm 4.063993491139e+04 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.588139591650e+03 lambda=2.5000000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.491163684413e+03 lambda=1.2500000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.802614760566e+03 lambda=5.7977212395253904e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.741444490992e+03 lambda=1.8448315876950813e-03 > Line search: Cubically determined step, current gnorm 1.739663656043e+03 lambda=7.7468345598227730e-04 > 9 SNES Function norm 1.739663656043e+03 > 0 KSP Residual norm 4.581839103558e+02 > 1 KSP Residual norm 2.627035885943e-11 > Line search: gnorm after quadratic fit 8.199478499066e+05 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.127270076812e+05 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.816774161281e+04 lambda=2.5000000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 4.053723877333e+03 lambda=1.2500000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.971814513392e+03 lambda=6.2500000000000003e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.755066208174e+03 lambda=2.7232010924558834e-03 > Line search: Cubically determined step, current gnorm 1.739559834479e+03 lambda=8.1458417855297680e-04 > 10 SNES Function norm 1.739559834479e+03 > 0 KSP Residual norm 1.463056810139e+02 > 1 KSP Residual norm 5.383584598825e-12 > Line search: gnorm after quadratic fit 2.885699620595e+04 > Line search: Cubic step no good, shrinking lambda, current gnorm 5.847717401708e+03 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.244464170034e+03 lambda=2.5000000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.769157604338e+03 lambda=1.0857209099577540e-02 > Line search: Cubically determined step, current gnorm 1.737356225452e+03 lambda=4.0312937622950231e-03 > 11 SNES Function norm 1.737356225452e+03 > 0 KSP Residual norm 1.564105677925e+02 > 1 KSP Residual norm 6.671164745832e-11 > Line search: gnorm after quadratic fit 3.815800291873e+04 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.197027796134e+03 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.373151605545e+03 lambda=2.5000000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.783976520867e+03 lambda=1.2093374970461970e-02 > Line search: Cubically determined step, current gnorm 1.735737929915e+03 lambda=4.9529698477569920e-03 > 12 SNES Function norm 1.735737929915e+03 > 0 KSP Residual norm 5.030757139645e+01 > 1 KSP Residual norm 1.157542730692e-12 > Line search: gnorm after quadratic fit 3.004544441458e+03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.850403239750e+03 lambda=5.0000000000000003e-02 > Line search: Cubically determined step, current gnorm 1.722893188305e+03 lambda=2.0881992439921702e-02 > 13 SNES Function norm 1.722893188305e+03 > 0 KSP Residual norm 7.123428853845e+01 > 1 KSP Residual norm 8.671726774894e-12 > Line search: gnorm after quadratic fit 4.361041499279e+03 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.032697222107e+03 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.726212330814e+03 lambda=1.9909470348267504e-02 > Line search: Cubically determined step, current gnorm 1.714127356920e+03 lambda=9.9547351741337518e-03 > 14 SNES Function norm 1.714127356920e+03 > 0 KSP Residual norm 8.304557447257e+00 > 1 KSP Residual norm 6.268295862688e-13 > Line search: gnorm after quadratic fit 1.558163002487e+03 > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > 15 SNES Function norm 1.558163002487e+03 > 0 KSP Residual norm 2.820803287164e+00 > 1 KSP Residual norm 5.477413853752e-13 > Line search: gnorm after quadratic fit 1.065673478530e+03 > Line search: Quadratically determined step, lambda=3.8943438938591052e-01 > 16 SNES Function norm 1.065673478530e+03 > 0 KSP Residual norm 2.296739120664e+00 > 1 KSP Residual norm 6.273731899885e-14 > Line search: gnorm after quadratic fit 8.964342150621e+02 > Line search: Quadratically determined step, lambda=1.8740736900935545e-01 > 17 SNES Function norm 8.964342150621e+02 > 0 KSP Residual norm 5.567568505830e+00 > 1 KSP Residual norm 8.649083600764e-12 > Line search: gnorm after quadratic fit 8.322514858992e+02 > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > 18 SNES Function norm 8.322514858992e+02 > 0 KSP Residual norm 1.164393577210e+00 > 1 KSP Residual norm 2.019248309015e-14 > Line search: Using full step: fnorm 8.322514858992e+02 gnorm 3.179750274746e+02 > 19 SNES Function norm 3.179750274746e+02 > 0 KSP Residual norm 5.339294310641e+00 > 1 KSP Residual norm 2.070321587238e-13 > Line search: gnorm after quadratic fit 3.433012316833e+02 > Line search: Cubically determined step, current gnorm 3.140305403821e+02 lambda=5.0000000000000003e-02 > 20 SNES Function norm 3.140305403821e+02 > 0 KSP Residual norm 1.177016565578e+01 > 1 KSP Residual norm 2.413027540446e-13 > Line search: gnorm after quadratic fit 7.377851778409e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.896721016582e+02 lambda=5.0000000000000003e-02 > Line search: Cubically determined step, current gnorm 3.136619309181e+02 lambda=9.7219892278716195e-03 > 21 SNES Function norm 3.136619309181e+02 > 0 KSP Residual norm 3.973565083977e+00 > 1 KSP Residual norm 9.726786674410e-14 > Line search: gnorm after quadratic fit 3.098277326090e+02 > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > 22 SNES Function norm 3.098277326090e+02 > 0 KSP Residual norm 9.389290683519e+00 > 1 KSP Residual norm 1.651497163724e-13 > Line search: gnorm after quadratic fit 6.887970540455e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.588146381477e+02 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.099274823603e+02 lambda=1.6890426151283184e-02 > Line search: Cubically determined step, current gnorm 3.084890760827e+02 lambda=8.4452130756415920e-03 > 23 SNES Function norm 3.084890760827e+02 > 0 KSP Residual norm 2.381130479641e+00 > 1 KSP Residual norm 4.694489283156e-14 > Line search: gnorm after quadratic fit 2.872151876535e+02 > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > 24 SNES Function norm 2.872151876535e+02 > 0 KSP Residual norm 2.405498502269e+00 > 1 KSP Residual norm 3.316846070538e-13 > Line search: gnorm after quadratic fit 2.686789761232e+02 > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > 25 SNES Function norm 2.686789761232e+02 > 0 KSP Residual norm 1.728772970554e+00 > 1 KSP Residual norm 4.132974383339e-14 > Line search: gnorm after quadratic fit 2.365009918229e+02 > Line search: Quadratically determined step, lambda=1.7273357529379074e-01 > 26 SNES Function norm 2.365009918229e+02 > 0 KSP Residual norm 4.413764759374e+00 > 1 KSP Residual norm 5.210690816917e-14 > Line search: gnorm after quadratic fit 2.756730968257e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.372321757171e+02 lambda=5.0000000000000003e-02 > Line search: Cubically determined step, current gnorm 2.335020811250e+02 lambda=2.5000000000000001e-02 > 27 SNES Function norm 2.335020811250e+02 > 0 KSP Residual norm 1.606246507553e+00 > 1 KSP Residual norm 3.564847846678e-14 > Line search: gnorm after quadratic fit 2.078263630653e+02 > Line search: Quadratically determined step, lambda=1.5913860995949433e-01 > 28 SNES Function norm 2.078263630653e+02 > 0 KSP Residual norm 3.700632954873e+00 > 1 KSP Residual norm 5.113863400264e-13 > Line search: gnorm after quadratic fit 2.142503514807e+02 > Line search: Cubically determined step, current gnorm 2.021095009118e+02 lambda=5.0000000000000003e-02 > 29 SNES Function norm 2.021095009118e+02 > 0 KSP Residual norm 3.056449560135e+00 > 1 KSP Residual norm 3.207987681334e-14 > Line search: gnorm after quadratic fit 2.064252530802e+02 > Line search: Cubically determined step, current gnorm 1.978069081639e+02 lambda=5.0000000000000003e-02 > 30 SNES Function norm 1.978069081639e+02 > 0 KSP Residual norm 2.024695620703e+00 > 1 KSP Residual norm 5.460360737995e-14 > Line search: gnorm after quadratic fit 1.839556530796e+02 > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > 31 SNES Function norm 1.839556530796e+02 > 0 KSP Residual norm 1.610676619931e+01 > 1 KSP Residual norm 6.703552136307e-13 > Line search: gnorm after quadratic fit 7.186735314913e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.905672430097e+02 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.856766286600e+02 lambda=1.0830798014298563e-02 > Line search: Cubically determined step, current gnorm 1.836818937131e+02 lambda=3.3207362501459785e-03 > 32 SNES Function norm 1.836818937131e+02 > 0 KSP Residual norm 7.471722173131e+01 > 1 KSP Residual norm 2.671534648829e-12 > Line search: gnorm after quadratic fit 9.613379909411e+04 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.509491298762e+04 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.808861367705e+03 lambda=2.5000000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.767283758299e+02 lambda=1.2500000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.665421328348e+02 lambda=6.0369453941238101e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.869726717041e+02 lambda=1.4394327006264963e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.836897704575e+02 lambda=1.4394327006264963e-04 > Line search: Cubically determined step, current gnorm 1.836767951408e+02 lambda=5.5567420418543164e-05 > 33 SNES Function norm 1.836767951408e+02 > 0 KSP Residual norm 2.702367712138e+01 > 1 KSP Residual norm 2.731656687850e-12 > Line search: gnorm after quadratic fit 3.331563146098e+03 > Line search: Cubic step no good, shrinking lambda, current gnorm 8.723694790688e+02 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.941243220944e+02 lambda=2.1443568774664485e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.847231733910e+02 lambda=2.7571330376860012e-03 > Line search: Cubically determined step, current gnorm 1.836356729409e+02 lambda=4.7841280418270480e-04 > 34 SNES Function norm 1.836356729409e+02 > 0 KSP Residual norm 1.228333177997e+01 > 1 KSP Residual norm 2.681127387880e-13 > Line search: gnorm after quadratic fit 6.936329223475e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.749327218775e+02 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.871557327742e+02 lambda=1.4160505301999991e-02 > Line search: Cubically determined step, current gnorm 1.833523080682e+02 lambda=3.5196326548579192e-03 > 35 SNES Function norm 1.833523080682e+02 > 0 KSP Residual norm 3.531886257396e+02 > 1 KSP Residual norm 2.364634092895e-11 > Line search: gnorm after quadratic fit 3.994783047929e+06 > Line search: Cubic step no good, shrinking lambda, current gnorm 4.753715960726e+05 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 5.516669898185e+04 lambda=2.5000000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.918985942348e+03 lambda=1.2500000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.363599250418e+03 lambda=6.2500000000000003e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 4.344906818752e+02 lambda=3.1250000000000002e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.991088183980e+02 lambda=1.0108094710462592e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.834621681844e+02 lambda=1.0108094710462593e-04 > Line search: Cubically determined step, current gnorm 1.833517377324e+02 lambda=1.0108094710462594e-05 > 36 SNES Function norm 1.833517377324e+02 > 0 KSP Residual norm 9.005833507118e+01 > 1 KSP Residual norm 6.116387880629e-12 > Line search: gnorm after quadratic fit 8.899847103226e+04 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.388111536526e+04 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.532652074749e+03 lambda=2.5000000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 5.864912734009e+02 lambda=1.2500000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.421068789960e+02 lambda=6.2500000000000003e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.873498120960e+02 lambda=2.1924025345283278e-03 > Line search: Cubically determined step, current gnorm 1.833506987706e+02 lambda=2.1924025345283280e-04 > 37 SNES Function norm 1.833506987706e+02 > 0 KSP Residual norm 1.548426525207e+01 > 1 KSP Residual norm 1.038038773942e-12 > Line search: gnorm after quadratic fit 6.702848665441e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.789880616078e+02 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.846521504351e+02 lambda=1.0567302644323170e-02 > Line search: Cubically determined step, current gnorm 1.830548481815e+02 lambda=3.5274490352771972e-03 > 38 SNES Function norm 1.830548481815e+02 > 0 KSP Residual norm 1.523095478807e+01 > 1 KSP Residual norm 1.963823596119e-12 > Line search: gnorm after quadratic fit 9.255727478491e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.496757253461e+02 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.863126241242e+02 lambda=9.3143291632966311e-03 > Line search: Cubically determined step, current gnorm 1.829091761403e+02 lambda=1.8107234819462800e-03 > 39 SNES Function norm 1.829091761403e+02 > 0 KSP Residual norm 1.311320726934e+01 > 1 KSP Residual norm 9.084170520902e-13 > Line search: gnorm after quadratic fit 7.488610069188e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.691148243365e+02 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.885558228772e+02 lambda=1.9439894235886539e-02 > Line search: Cubically determined step, current gnorm 1.825540619134e+02 lambda=5.4967824488704169e-03 > 40 SNES Function norm 1.825540619134e+02 > 0 KSP Residual norm 1.218635557505e+01 > 1 KSP Residual norm 7.760485728617e-13 > Line search: gnorm after quadratic fit 6.636453826807e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.880828006022e+02 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.830493790584e+02 lambda=6.6234802648049863e-03 > Line search: Cubically determined step, current gnorm 1.823397545268e+02 lambda=2.4308217464828865e-03 > 41 SNES Function norm 1.823397545268e+02 > 0 KSP Residual norm 9.456543593865e+00 > 1 KSP Residual norm 7.046593270309e-13 > Line search: gnorm after quadratic fit 3.369769163110e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.105230957789e+02 lambda=5.0000000000000003e-02 > Line search: Cubically determined step, current gnorm 1.817897533119e+02 lambda=9.1612481372917148e-03 > 42 SNES Function norm 1.817897533119e+02 > 0 KSP Residual norm 7.290035145805e+00 > 1 KSP Residual norm 3.198962158141e-12 > Line search: gnorm after quadratic fit 2.858311567415e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.965004842981e+02 lambda=5.0000000000000003e-02 > Line search: Cubically determined step, current gnorm 1.808845577764e+02 lambda=1.3826421990147811e-02 > 43 SNES Function norm 1.808845577764e+02 > 0 KSP Residual norm 7.256785036157e+00 > 1 KSP Residual norm 9.243179217625e-14 > Line search: gnorm after quadratic fit 2.534388176390e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.916726818893e+02 lambda=5.0000000000000003e-02 > Line search: Cubically determined step, current gnorm 1.797953125543e+02 lambda=1.3677747819164022e-02 > 44 SNES Function norm 1.797953125543e+02 > 0 KSP Residual norm 1.716201096352e+01 > 1 KSP Residual norm 2.701418800808e-13 > Line search: gnorm after quadratic fit 1.331064301474e+03 > Line search: Cubic step no good, shrinking lambda, current gnorm 4.461842246267e+02 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.920668830294e+02 lambda=1.2856504859057132e-02 > Line search: Cubically determined step, current gnorm 1.797121460957e+02 lambda=1.4396611381500967e-03 > 45 SNES Function norm 1.797121460957e+02 > 0 KSP Residual norm 6.613432967985e+00 > 1 KSP Residual norm 1.357752977076e-13 > Line search: gnorm after quadratic fit 2.721288927858e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.939638282615e+02 lambda=5.0000000000000003e-02 > Line search: Cubically determined step, current gnorm 1.787985482018e+02 lambda=1.2647907914070569e-02 > 46 SNES Function norm 1.787985482018e+02 > 0 KSP Residual norm 1.225736349281e+01 > 1 KSP Residual norm 3.819378790812e-13 > Line search: gnorm after quadratic fit 4.548006065036e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.304803559060e+02 lambda=5.0000000000000003e-02 > Line search: Cubically determined step, current gnorm 1.787344729174e+02 lambda=8.9002284237256531e-03 > 47 SNES Function norm 1.787344729174e+02 > 0 KSP Residual norm 6.302465402340e+00 > 1 KSP Residual norm 6.980931947122e-14 > Line search: gnorm after quadratic fit 2.879477700004e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.980806946742e+02 lambda=5.0000000000000003e-02 > Line search: Cubically determined step, current gnorm 1.780128006935e+02 lambda=1.0223293444602008e-02 > 48 SNES Function norm 1.780128006935e+02 > 0 KSP Residual norm 4.323829277968e+00 > 1 KSP Residual norm 5.223881369308e-13 > Line search: gnorm after quadratic fit 1.957928151218e+02 > Line search: Cubically determined step, current gnorm 1.768899805640e+02 lambda=5.0000000000000003e-02 > 49 SNES Function norm 1.768899805640e+02 > 0 KSP Residual norm 2.249256107033e+00 > 1 KSP Residual norm 3.624400957270e-14 > Line search: gnorm after quadratic fit 1.704782114773e+02 > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > 50 SNES Function norm 1.704782114773e+02 > 0 SNES Function norm 3.513783397332e+03 > 0 KSP Residual norm 1.650214950648e+01 > 1 KSP Residual norm 3.574269752690e-13 > Line search: gnorm after quadratic fit 3.155830404050e+03 > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > 1 SNES Function norm 3.155830404050e+03 > 0 KSP Residual norm 1.443734018042e+01 > 1 KSP Residual norm 3.685565191058e-13 > Line search: Using full step: fnorm 3.155830404050e+03 gnorm 8.581212204155e+02 > 2 SNES Function norm 8.581212204155e+02 > 0 KSP Residual norm 2.492601775565e+00 > 1 KSP Residual norm 9.698440210389e-14 > Line search: Using full step: fnorm 8.581212204155e+02 gnorm 7.018609898542e+02 > 3 SNES Function norm 7.018609898542e+02 > 0 KSP Residual norm 1.740320986421e+00 > 1 KSP Residual norm 2.868780682435e-14 > Line search: Using full step: fnorm 7.018609898542e+02 gnorm 2.135824235887e+02 > 4 SNES Function norm 2.135824235887e+02 > 0 KSP Residual norm 1.647413497077e+00 > 1 KSP Residual norm 2.731226225666e-14 > Line search: gnorm after quadratic fit 1.936469032649e+02 > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > 5 SNES Function norm 1.936469032649e+02 > 0 KSP Residual norm 1.406615972124e+00 > 1 KSP Residual norm 3.167179626699e-14 > Line search: gnorm after quadratic fit 1.755362571467e+02 > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > 6 SNES Function norm 1.755362571467e+02 > 0 KSP Residual norm 1.480681706594e+00 > 1 KSP Residual norm 2.935210968935e-14 > Line search: gnorm after quadratic fit 1.597659506616e+02 > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > 7 SNES Function norm 1.597659506616e+02 > 0 KSP Residual norm 4.013154698097e+00 > 1 KSP Residual norm 1.021628704832e-13 > Line search: gnorm after quadratic fit 1.728408060966e+02 > Line search: Cubically determined step, current gnorm 1.570815760721e+02 lambda=5.0000000000000003e-02 > 8 SNES Function norm 1.570815760721e+02 > 0 KSP Residual norm 1.510335662636e+00 > 1 KSP Residual norm 2.728243244724e-14 > Line search: gnorm after quadratic fit 1.450162880692e+02 > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > 9 SNES Function norm 1.450162880692e+02 > 0 KSP Residual norm 1.923349271077e+01 > 1 KSP Residual norm 1.640711956406e-11 > Line search: gnorm after quadratic fit 1.016537223115e+03 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.584263092048e+02 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.490729346583e+02 lambda=9.3725990358703350e-03 > Line search: Cubically determined step, current gnorm 1.449349273006e+02 lambda=1.5464889706033082e-03 > 10 SNES Function norm 1.449349273006e+02 > 0 KSP Residual norm 1.154999084194e+01 > 1 KSP Residual norm 1.292167633338e-11 > Line search: gnorm after quadratic fit 6.060386918705e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.236630526035e+02 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.491201927819e+02 lambda=1.6816056300124185e-02 > Line search: Cubically determined step, current gnorm 1.447023047013e+02 lambda=4.1484374564153808e-03 > 11 SNES Function norm 1.447023047013e+02 > 0 KSP Residual norm 7.278906180502e+00 > 1 KSP Residual norm 2.815632651924e-12 > Line search: gnorm after quadratic fit 2.512278711773e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.624350957814e+02 lambda=5.0000000000000003e-02 > Line search: Cubically determined step, current gnorm 1.441656049510e+02 lambda=1.0879389002513012e-02 > 12 SNES Function norm 1.441656049510e+02 > 0 KSP Residual norm 4.449836480267e+00 > 1 KSP Residual norm 3.152365624813e-13 > Line search: gnorm after quadratic fit 1.749680739878e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.458763435996e+02 lambda=5.0000000000000003e-02 > Line search: Cubically determined step, current gnorm 1.425715025152e+02 lambda=2.2766809271842225e-02 > 13 SNES Function norm 1.425715025152e+02 > 0 KSP Residual norm 4.218495037726e+00 > 1 KSP Residual norm 1.398472536142e-12 > Line search: gnorm after quadratic fit 1.645159536467e+02 > Line search: Cubically determined step, current gnorm 1.421991559212e+02 lambda=4.1883769431247941e-02 > 14 SNES Function norm 1.421991559212e+02 > 0 KSP Residual norm 1.968853538608e+00 > 1 KSP Residual norm 7.594023450519e-12 > Line search: gnorm after quadratic fit 1.350960142124e+02 > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > 15 SNES Function norm 1.350960142124e+02 > 0 KSP Residual norm 3.444721686085e+00 > 1 KSP Residual norm 5.312609674019e-14 > Line search: gnorm after quadratic fit 1.472880565107e+02 > Line search: Cubically determined step, current gnorm 1.336714620145e+02 lambda=4.1341550820829437e-02 > 16 SNES Function norm 1.336714620145e+02 > 0 KSP Residual norm 3.276288899397e+00 > 1 KSP Residual norm 8.394674946715e-14 > Line search: gnorm after quadratic fit 1.459274497150e+02 > Line search: Cubically determined step, current gnorm 1.327618539486e+02 lambda=5.0000000000000003e-02 > 17 SNES Function norm 1.327618539486e+02 > 0 KSP Residual norm 2.630052244303e+00 > 1 KSP Residual norm 4.351283410507e-14 > Line search: gnorm after quadratic fit 1.350378060116e+02 > Line search: Cubically determined step, current gnorm 1.299403903934e+02 lambda=4.9913529436269283e-02 > 18 SNES Function norm 1.299403903934e+02 > 0 KSP Residual norm 6.124953430138e+00 > 1 KSP Residual norm 2.295381352938e-13 > Line search: gnorm after quadratic fit 2.275621676963e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.469611730657e+02 lambda=5.0000000000000003e-02 > Line search: Cubically determined step, current gnorm 1.294890694898e+02 lambda=1.0071939100661648e-02 > 19 SNES Function norm 1.294890694898e+02 > 0 KSP Residual norm 1.036733907011e+01 > 1 KSP Residual norm 1.800941381283e-13 > Line search: gnorm after quadratic fit 3.844879463595e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.875071148504e+02 lambda=5.0000000000000003e-02 > Line search: Cubically determined step, current gnorm 1.294494430642e+02 lambda=5.0000000000000010e-03 > 20 SNES Function norm 1.294494430642e+02 > 0 KSP Residual norm 8.224001595443e+00 > 1 KSP Residual norm 3.337810156182e-13 > Line search: gnorm after quadratic fit 3.332325263497e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.682441841234e+02 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.294720538860e+02 lambda=8.5401597581228530e-03 > Line search: Cubically determined step, current gnorm 1.291762382985e+02 lambda=4.2555418164960989e-03 > 21 SNES Function norm 1.291762382985e+02 > 0 KSP Residual norm 3.920749219860e+01 > 1 KSP Residual norm 1.610902886435e-12 > Line search: gnorm after quadratic fit 3.472422440640e+03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.023065712859e+03 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.228184088700e+02 lambda=1.6004598823093592e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.298607525058e+02 lambda=1.6004598823093593e-03 > Line search: Cubically determined step, current gnorm 1.291643460998e+02 lambda=1.9319076533745672e-04 > 22 SNES Function norm 1.291643460998e+02 > 0 KSP Residual norm 1.520092314848e+02 > 1 KSP Residual norm 7.089159192434e-11 > Line search: gnorm after quadratic fit 2.752539686422e+05 > Line search: Cubic step no good, shrinking lambda, current gnorm 4.237188995536e+04 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.484370498858e+03 lambda=2.5000000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.571039994484e+03 lambda=1.2500000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 4.280898858362e+02 lambda=6.2500000000000003e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.708927009106e+02 lambda=2.6114913411793973e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.294919567784e+02 lambda=2.6114913411793975e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291645609810e+02 lambda=2.6114913411793977e-05 > Line search: Cubically determined step, current gnorm 1.291635530596e+02 lambda=1.2278773895355162e-05 > 23 SNES Function norm 1.291635530596e+02 > 0 KSP Residual norm 7.569206058965e+02 > 1 KSP Residual norm 3.454693729751e-11 > Line search: gnorm after quadratic fit 2.570888738395e+07 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.064965025187e+06 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.498514098182e+05 lambda=2.5000000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.807487005202e+04 lambda=1.2500000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 5.233167830543e+03 lambda=6.2500000000000003e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.396736912757e+03 lambda=3.1250000000000002e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.547572543330e+02 lambda=1.2623406091699435e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.335889024473e+02 lambda=1.8542137907683829e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.292059042479e+02 lambda=1.8542137907683831e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291637618568e+02 lambda=1.8542137907683832e-06 > Line search: Cubically determined step, current gnorm 1.291635210734e+02 lambda=4.9524172913414387e-07 > 24 SNES Function norm 1.291635210734e+02 > 0 KSP Residual norm 3.761913422861e+03 > 1 KSP Residual norm 6.181718776929e-10 > Line search: gnorm after quadratic fit 3.342370445037e+09 > Line search: Cubic step no good, shrinking lambda, current gnorm 4.218326646111e+08 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 5.375128803204e+07 lambda=2.5000000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.980626157021e+06 lambda=1.2500000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 9.407418671219e+05 lambda=6.2500000000000003e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.357321025399e+05 lambda=3.1250000000000002e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.188948059047e+04 lambda=1.5625000000000001e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 4.105117929713e+03 lambda=7.8125000000000004e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 9.331054736818e+02 lambda=3.9062500000000002e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.942479792843e+02 lambda=1.9412500272460620e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.436944624694e+02 lambda=6.4483223307578726e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.292972287211e+02 lambda=6.4483223307578726e-06 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291647778160e+02 lambda=6.4483223307578730e-07 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635261433e+02 lambda=6.4483223307578730e-08 > Line search: Cubically determined step, current gnorm 1.291635197798e+02 lambda=2.0042115918485846e-08 > 25 SNES Function norm 1.291635197798e+02 > 0 KSP Residual norm 1.874745766083e+04 > 1 KSP Residual norm 1.476978150334e-09 > Line search: gnorm after quadratic fit 4.089262111368e+11 > Line search: Cubic step no good, shrinking lambda, current gnorm 5.101717203770e+10 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.352565940292e+09 lambda=2.5000000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.879613196620e+08 lambda=1.2500000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 9.698613558125e+07 lambda=6.2500000000000003e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.175566265039e+07 lambda=3.1250000000000002e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.382919964952e+06 lambda=1.5625000000000001e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.545431975334e+05 lambda=7.8125000000000004e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.713561369103e+04 lambda=3.9062500000000002e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.031789308419e+03 lambda=1.9531250000000001e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 9.205847020738e+02 lambda=9.7656250000000005e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.957203153158e+02 lambda=2.8132879163728503e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.297923302791e+02 lambda=2.8132879163728504e-06 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291698100579e+02 lambda=2.8132879163728504e-07 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635794525e+02 lambda=2.8132879163728506e-08 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635200489e+02 lambda=2.8132879163728508e-09 > Line search: Cubically determined step, current gnorm 1.291635197275e+02 lambda=8.0832061492461345e-10 > 26 SNES Function norm 1.291635197275e+02 > 0 KSP Residual norm 9.248381077528e+04 > 1 KSP Residual norm 7.262307068447e-09 > Line search: gnorm after quadratic fit 4.920647210624e+13 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.153216818065e+12 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.697543960375e+11 lambda=2.5000000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 9.637004379805e+10 lambda=1.2500000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.208402653149e+10 lambda=6.2500000000000003e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.519988135798e+09 lambda=3.1250000000000002e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.923903214787e+08 lambda=1.5625000000000001e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.465663001976e+07 lambda=7.8125000000000004e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.238603967195e+06 lambda=3.9062500000000002e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 4.459179143177e+05 lambda=1.9531250000000001e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.676301042792e+04 lambda=9.7656250000000005e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.135808875752e+04 lambda=4.8828125000000003e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.275714918657e+03 lambda=2.4414062500000001e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 5.719037747616e+02 lambda=1.2207031250000001e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.039826156716e+02 lambda=5.5609199181402721e-06 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.308092967809e+02 lambda=9.1057337296683134e-07 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291796742824e+02 lambda=9.1057337296683134e-08 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291636800174e+02 lambda=9.1057337296683134e-09 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635212255e+02 lambda=9.1057337296683134e-10 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635197320e+02 lambda=9.1057337296683139e-11 > Line search: Cubically determined step, current gnorm 1.291635197254e+02 lambda=3.2898162617097329e-11 > 27 SNES Function norm 1.291635197254e+02 > 0 KSP Residual norm 4.818745996826e+05 > 1 KSP Residual norm 3.300979345194e-08 > Line search: gnorm after quadratic fit 6.957046028867e+15 > Line search: Cubic step no good, shrinking lambda, current gnorm 8.695654311477e+14 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.086793500688e+14 lambda=2.5000000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.358083744813e+13 lambda=1.2500000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.696584801696e+12 lambda=6.2500000000000003e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.118183549773e+11 lambda=3.1250000000000002e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.641372080976e+10 lambda=1.5625000000000001e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.285878535769e+09 lambda=7.8125000000000004e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 4.068045470276e+08 lambda=3.9062500000000002e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 4.988290932539e+07 lambda=1.9531250000000001e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.001404304764e+06 lambda=9.7656250000000005e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.962234585736e+05 lambda=4.8828125000000003e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.648190078115e+04 lambda=2.4414062500000001e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 9.098288624714e+03 lambda=1.2207031250000001e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.025132922751e+03 lambda=6.1035156250000003e-06 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.536770142392e+02 lambda=3.0517578125000002e-06 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.529553964021e+02 lambda=6.6615844706846272e-07 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.293970371303e+02 lambda=6.6615844706846277e-08 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291658631829e+02 lambda=6.6615844706846284e-09 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635430890e+02 lambda=6.6615844706846284e-10 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635199508e+02 lambda=6.6615844706846284e-11 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635197268e+02 lambda=6.6615844706846284e-12 > Line search: Cubically determined step, current gnorm 1.291635197253e+02 lambda=1.2496728806533799e-12 > 28 SNES Function norm 1.291635197253e+02 > 0 KSP Residual norm 2.124622394867e+06 > 1 KSP Residual norm 2.766225333896e-07 > Line search: gnorm after quadratic fit 5.963587884154e+17 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.454611858824e+16 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 9.318582340500e+15 lambda=2.5000000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.164902175749e+15 lambda=1.2500000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.456326197371e+14 lambda=6.2500000000000003e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.820904039469e+13 lambda=3.1250000000000002e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.277371273495e+12 lambda=1.5625000000000001e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.849819609184e+11 lambda=7.8125000000000004e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.570050545145e+10 lambda=3.9062500000000002e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 4.482064028328e+09 lambda=1.9531250000000001e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 5.651631635063e+08 lambda=9.7656250000000005e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.188623828904e+07 lambda=4.8828125000000003e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 9.302868645305e+06 lambda=2.4414062500000001e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.245214424313e+06 lambda=1.2207031250000001e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.775004618570e+05 lambda=6.1035156250000003e-06 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.810228834086e+04 lambda=3.0517578125000002e-06 > Line search: Cubic step no good, shrinking lambda, current gnorm 5.148910945566e+03 lambda=1.5258789062500001e-06 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.133679879416e+03 lambda=7.6293945312500004e-07 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.382468615011e+02 lambda=3.8146972656250002e-07 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.519773483633e+02 lambda=1.4103864371136453e-07 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.293690599792e+02 lambda=1.4103864371136454e-08 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291655645282e+02 lambda=1.4103864371136455e-09 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635401518e+02 lambda=1.4103864371136456e-10 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635199283e+02 lambda=1.4103864371136456e-11 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635197272e+02 lambda=1.4103864371136456e-12 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635197253e+02 lambda=1.4103864371136457e-13 > Line search: unable to find good step length! After 25 tries > Line search: fnorm=1.2916351972528861e+02, gnorm=1.2916351972529532e+02, ynorm=2.1246218291095798e+06, minlambda=9.9999999999999998e-13, lambda=1.4103864371136457e-13, initial slope=-1.6683210999382733e+04 > 0 SNES Function norm 7.158176401507e+03 > 0 KSP Residual norm 7.545626598553e+02 > 1 KSP Residual norm 2.192822940623e-11 > Line search: gnorm after quadratic fit 6.003975664723e+07 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.501930637484e+06 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 9.380142516806e+05 lambda=2.5000000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.179837352860e+05 lambda=1.2500000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.656902039419e+04 lambda=6.2500000000000003e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.340091686120e+03 lambda=3.1250000000000002e-03 > Line search: Cubically determined step, current gnorm 7.127478647243e+03 lambda=1.5625000000000001e-03 > 1 SNES Function norm 7.127478647243e+03 > 0 KSP Residual norm 3.139792512249e+01 > 1 KSP Residual norm 5.765552480238e-13 > Line search: gnorm after quadratic fit 7.131728282938e+03 > Line search: Cubically determined step, current gnorm 6.730387269330e+03 lambda=5.0000000000000003e-02 > 2 SNES Function norm 6.730387269330e+03 > 0 KSP Residual norm 2.247436817553e+01 > 1 KSP Residual norm 4.129717651221e-13 > Line search: gnorm after quadratic fit 6.018304311910e+03 > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > 3 SNES Function norm 6.018304311910e+03 > 0 KSP Residual norm 1.605973421081e+01 > 1 KSP Residual norm 3.614891198134e-13 > Line search: gnorm after quadratic fit 5.394599276028e+03 > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > 4 SNES Function norm 5.394599276028e+03 > 0 KSP Residual norm 1.491002227850e+01 > 1 KSP Residual norm 5.905756964447e-13 > Line search: gnorm after quadratic fit 4.845108544722e+03 > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > 5 SNES Function norm 4.845108544722e+03 > 0 KSP Residual norm 1.562997766581e+02 > 1 KSP Residual norm 5.722461855805e-12 > Line search: gnorm after quadratic fit 1.663505509947e+05 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.368547472010e+04 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.067825049920e+03 lambda=2.5000000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 4.852173464442e+03 lambda=1.2500000000000001e-02 > Line search: Cubically determined step, current gnorm 4.819549937425e+03 lambda=6.2500000000000003e-03 > 6 SNES Function norm 4.819549937425e+03 > 0 KSP Residual norm 1.652787385042e+01 > 1 KSP Residual norm 7.774483442550e-13 > Line search: gnorm after quadratic fit 2.868840270198e+03 > Line search: Quadratically determined step, lambda=3.9586658383856743e-01 > 7 SNES Function norm 2.868840270198e+03 > 0 KSP Residual norm 1.220061851091e+01 > 1 KSP Residual norm 4.785407437718e-13 > Line search: gnorm after quadratic fit 2.616720732407e+03 > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > 8 SNES Function norm 2.616720732407e+03 > 0 KSP Residual norm 2.884722153958e+01 > 1 KSP Residual norm 5.474553921306e-13 > Line search: gnorm after quadratic fit 3.025386805317e+03 > Line search: Cubically determined step, current gnorm 2.572110173067e+03 lambda=5.0000000000000003e-02 > 9 SNES Function norm 2.572110173067e+03 > 0 KSP Residual norm 5.239447686736e+01 > 1 KSP Residual norm 1.006906008399e-12 > Line search: gnorm after quadratic fit 5.237562098046e+03 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.722529781980e+03 lambda=5.0000000000000003e-02 > Line search: Cubically determined step, current gnorm 2.553072891461e+03 lambda=2.5000000000000001e-02 > 10 SNES Function norm 2.553072891461e+03 > 0 KSP Residual norm 6.511316788880e+00 > 1 KSP Residual norm 1.340296659008e-13 > Line search: gnorm after quadratic fit 2.299704119080e+03 > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > 11 SNES Function norm 2.299704119080e+03 > 0 KSP Residual norm 5.268131426587e+00 > 1 KSP Residual norm 1.017563310127e-13 > Line search: Using full step: fnorm 2.299704119080e+03 gnorm 7.642690039388e+02 > 12 SNES Function norm 7.642690039388e+02 > 0 KSP Residual norm 1.467735721574e+01 > 1 KSP Residual norm 1.090242963543e-12 > Line search: gnorm after quadratic fit 1.042766084830e+03 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.924803860137e+02 lambda=5.0000000000000003e-02 > Line search: Cubically determined step, current gnorm 7.581126971182e+02 lambda=1.8508848315139208e-02 > 13 SNES Function norm 7.581126971182e+02 > 0 KSP Residual norm 2.222609581896e+00 > 1 KSP Residual norm 5.661437314341e-14 > Line search: gnorm after quadratic fit 6.235337602260e+02 > Line search: Quadratically determined step, lambda=2.1172883827013136e-01 > 14 SNES Function norm 6.235337602260e+02 > 0 KSP Residual norm 3.080209609798e+00 > 1 KSP Residual norm 6.073476899313e-14 > Line search: gnorm after quadratic fit 5.704745248520e+02 > Line search: Quadratically determined step, lambda=1.0142301129466913e-01 > 15 SNES Function norm 5.704745248520e+02 > 0 KSP Residual norm 5.628316803979e+00 > 1 KSP Residual norm 9.930477041779e-14 > Line search: gnorm after quadratic fit 5.401354794776e+02 > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > 16 SNES Function norm 5.401354794776e+02 > 0 KSP Residual norm 2.052541406719e+01 > 1 KSP Residual norm 4.328836834239e-13 > Line search: gnorm after quadratic fit 1.709850100987e+03 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.717966555703e+02 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 5.414032576976e+02 lambda=8.7805694170804971e-03 > Line search: Cubically determined step, current gnorm 5.391967144330e+02 lambda=3.6341472475199424e-03 > 17 SNES Function norm 5.391967144330e+02 > 0 KSP Residual norm 2.246993769488e+00 > 1 KSP Residual norm 5.078373642913e-14 > Line search: gnorm after quadratic fit 4.939618639951e+02 > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > 18 SNES Function norm 4.939618639951e+02 > 0 KSP Residual norm 2.155867648564e+00 > 1 KSP Residual norm 4.438622106380e-14 > Line search: gnorm after quadratic fit 4.334377322188e+02 > Line search: Quadratically determined step, lambda=1.5092486954829210e-01 > 19 SNES Function norm 4.334377322188e+02 > 0 KSP Residual norm 8.318284791610e+00 > 1 KSP Residual norm 6.910116607023e-13 > Line search: gnorm after quadratic fit 6.148799641401e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 4.502386288041e+02 lambda=5.0000000000000003e-02 > Line search: Cubically determined step, current gnorm 4.297879862602e+02 lambda=1.9565738732695813e-02 > 20 SNES Function norm 4.297879862602e+02 > 0 KSP Residual norm 7.593855254976e+01 > 1 KSP Residual norm 1.300639045149e-12 > Line search: gnorm after quadratic fit 7.318016560287e+04 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.832525429452e+03 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.543595712952e+03 lambda=2.5000000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.752901058720e+02 lambda=1.2500000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 4.309726315570e+02 lambda=1.2500000000000002e-03 > Line search: Cubically determined step, current gnorm 4.297464967378e+02 lambda=2.0986409143217158e-04 > 21 SNES Function norm 4.297464967378e+02 > 0 KSP Residual norm 8.492609701850e+00 > 1 KSP Residual norm 2.830329105288e-13 > Line search: gnorm after quadratic fit 6.575200413213e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 4.532760802544e+02 lambda=5.0000000000000003e-02 > Line search: Cubically determined step, current gnorm 4.268212296998e+02 lambda=1.8460064973695799e-02 > 22 SNES Function norm 4.268212296998e+02 > 0 KSP Residual norm 2.527155905469e+00 > 1 KSP Residual norm 2.235724978394e-13 > Line search: gnorm after quadratic fit 3.958132075117e+02 > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > 23 SNES Function norm 3.958132075117e+02 > 0 KSP Residual norm 3.425644398425e+00 > 1 KSP Residual norm 7.166017790799e-14 > Line search: gnorm after quadratic fit 3.803199338641e+02 > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > 24 SNES Function norm 3.803199338641e+02 > 0 KSP Residual norm 3.581435186688e+00 > 1 KSP Residual norm 1.730091027109e-13 > Line search: gnorm after quadratic fit 3.678433353709e+02 > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > 25 SNES Function norm 3.678433353709e+02 > 0 KSP Residual norm 2.817439291614e+00 > 1 KSP Residual norm 8.592333136485e-13 > Line search: gnorm after quadratic fit 3.472671313564e+02 > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > 26 SNES Function norm 3.472671313564e+02 > 0 KSP Residual norm 1.830066839089e+00 > 1 KSP Residual norm 3.248934231575e-14 > Line search: gnorm after quadratic fit 3.195079998571e+02 > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > 27 SNES Function norm 3.195079998571e+02 > 0 KSP Residual norm 3.775823654589e+00 > 1 KSP Residual norm 1.316233059492e-13 > Line search: gnorm after quadratic fit 3.252874639934e+02 > Line search: Cubically determined step, current gnorm 3.125168318399e+02 lambda=5.0000000000000003e-02 > 28 SNES Function norm 3.125168318399e+02 > 0 KSP Residual norm 3.892613775622e+00 > 1 KSP Residual norm 7.093200713216e-11 > Line search: gnorm after quadratic fit 3.137590389484e+02 > Line search: Cubically determined step, current gnorm 3.045559021319e+02 lambda=5.0000000000000003e-02 > 29 SNES Function norm 3.045559021319e+02 > 0 KSP Residual norm 2.364531179390e+00 > 1 KSP Residual norm 1.615423543115e-12 > Line search: gnorm after quadratic fit 2.864449141431e+02 > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > 30 SNES Function norm 2.864449141431e+02 > 0 KSP Residual norm 5.187063704081e+00 > 1 KSP Residual norm 4.254799504045e-13 > Line search: gnorm after quadratic fit 3.171238299438e+02 > Line search: Cubically determined step, current gnorm 2.859321807369e+02 lambda=4.9550691080557742e-02 > 31 SNES Function norm 2.859321807369e+02 > 0 KSP Residual norm 2.400449127985e+01 > 1 KSP Residual norm 5.221032480453e-13 > Line search: gnorm after quadratic fit 1.812538817802e+03 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.647888939229e+02 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.905120335847e+02 lambda=7.3371687404129469e-03 > Line search: Cubically determined step, current gnorm 2.857698450683e+02 lambda=1.3231746793531958e-03 > 32 SNES Function norm 2.857698450683e+02 > 0 KSP Residual norm 7.438521293559e+00 > 1 KSP Residual norm 1.293652874831e-12 > Line search: gnorm after quadratic fit 3.600694148787e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.932936811991e+02 lambda=5.0000000000000003e-02 > Line search: Cubically determined step, current gnorm 2.832774969882e+02 lambda=1.8636088141277370e-02 > 33 SNES Function norm 2.832774969882e+02 > 0 KSP Residual norm 2.676138557891e+00 > 1 KSP Residual norm 5.204105674042e-12 > Line search: gnorm after quadratic fit 2.698470565576e+02 > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > 34 SNES Function norm 2.698470565576e+02 > 0 KSP Residual norm 1.009562156863e+01 > 1 KSP Residual norm 3.544140587695e-13 > Line search: gnorm after quadratic fit 5.672695948559e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.197216154647e+02 lambda=5.0000000000000003e-02 > Line search: Cubically determined step, current gnorm 2.694068135292e+02 lambda=1.0762403784106927e-02 > 35 SNES Function norm 2.694068135292e+02 > 0 KSP Residual norm 3.927549314525e+00 > 1 KSP Residual norm 2.619134786598e-13 > Line search: gnorm after quadratic fit 2.646675787349e+02 > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > 36 SNES Function norm 2.646675787349e+02 > 0 KSP Residual norm 3.630219417922e+01 > 1 KSP Residual norm 1.546302717349e-12 > Line search: gnorm after quadratic fit 1.827432666108e+04 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.342968941151e+03 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 8.008633273369e+02 lambda=2.5000000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.490753494196e+02 lambda=1.2345129233072847e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.682474011960e+02 lambda=3.3291959087019770e-03 > Line search: Cubically determined step, current gnorm 2.646227701989e+02 lambda=4.0529212866107715e-04 > 37 SNES Function norm 2.646227701989e+02 > 0 KSP Residual norm 8.122774697994e+00 > 1 KSP Residual norm 1.316362046092e-13 > Line search: gnorm after quadratic fit 4.731092571363e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.030088374328e+02 lambda=5.0000000000000003e-02 > Line search: Cubically determined step, current gnorm 2.637462652877e+02 lambda=9.1057248517509397e-03 > 38 SNES Function norm 2.637462652877e+02 > 0 KSP Residual norm 2.601520363063e+00 > 1 KSP Residual norm 1.060764270007e-12 > Line search: gnorm after quadratic fit 2.536856446094e+02 > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > 39 SNES Function norm 2.536856446094e+02 > 0 KSP Residual norm 5.447955134327e+01 > 1 KSP Residual norm 2.556989975730e-12 > Line search: gnorm after quadratic fit 9.199250935618e+03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.998238940105e+03 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.227083769291e+02 lambda=2.5000000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.852215674478e+02 lambda=8.5024965111563117e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.537821339347e+02 lambda=8.5024965111563122e-04 > Line search: Cubically determined step, current gnorm 2.536484146652e+02 lambda=2.9594242443314720e-04 > 40 SNES Function norm 2.536484146652e+02 > 0 KSP Residual norm 3.357359266965e+01 > 1 KSP Residual norm 8.485166742752e-11 > Line search: gnorm after quadratic fit 3.327150899857e+03 > Line search: Cubic step no good, shrinking lambda, current gnorm 8.660943990394e+02 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.428891921377e+02 lambda=2.2262238648584176e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.550059920785e+02 lambda=3.9120439672600755e-03 > Line search: Cubically determined step, current gnorm 2.535425543202e+02 lambda=8.8078244093807846e-04 > 41 SNES Function norm 2.535425543202e+02 > 0 KSP Residual norm 1.982789391732e+01 > 1 KSP Residual norm 1.156473750758e-11 > Line search: gnorm after quadratic fit 9.648483369708e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 4.023504841042e+02 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.554919970151e+02 lambda=8.7092873850291869e-03 > Line search: Cubically determined step, current gnorm 2.532490636747e+02 lambda=2.4564558988847251e-03 > 42 SNES Function norm 2.532490636747e+02 > 0 KSP Residual norm 1.762994613361e+01 > 1 KSP Residual norm 4.550684860593e-12 > Line search: gnorm after quadratic fit 6.772107527838e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.370541870778e+02 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.532869639177e+02 lambda=7.7662700854918328e-03 > Line search: Cubically determined step, current gnorm 2.527651129995e+02 lambda=3.8686733161537824e-03 > 43 SNES Function norm 2.527651129995e+02 > 0 KSP Residual norm 1.559278923951e+01 > 1 KSP Residual norm 1.060470887103e-11 > Line search: gnorm after quadratic fit 7.344361373020e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.498001534426e+02 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.530518382567e+02 lambda=7.6730113050967469e-03 > Line search: Cubically determined step, current gnorm 2.523423548732e+02 lambda=3.4156098513217236e-03 > 44 SNES Function norm 2.523423548732e+02 > 0 KSP Residual norm 1.190500639095e+01 > 1 KSP Residual norm 6.311739265577e-12 > Line search: gnorm after quadratic fit 4.875196633557e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.933215922947e+02 lambda=5.0000000000000003e-02 > Line search: Cubically determined step, current gnorm 2.516782376717e+02 lambda=9.8878729665301743e-03 > 45 SNES Function norm 2.516782376717e+02 > 0 KSP Residual norm 1.003632001309e+01 > 1 KSP Residual norm 7.039473047666e-13 > Line search: gnorm after quadratic fit 3.417133560813e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.636443273929e+02 lambda=5.0000000000000003e-02 > Line search: Cubically determined step, current gnorm 2.499729768042e+02 lambda=1.5332495922160540e-02 > 46 SNES Function norm 2.499729768042e+02 > 0 KSP Residual norm 5.252587112411e+01 > 1 KSP Residual norm 2.072629114336e-12 > Line search: gnorm after quadratic fit 7.891803681498e+03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.819076698717e+03 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 5.911876424956e+02 lambda=2.4538865368827514e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.688195882303e+02 lambda=6.5764457912135515e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.500076295129e+02 lambda=6.5764457912135523e-04 > Line search: Cubically determined step, current gnorm 2.499390700783e+02 lambda=2.7231956365922875e-04 > 47 SNES Function norm 2.499390700783e+02 > 0 KSP Residual norm 4.007648116930e+01 > 1 KSP Residual norm 5.646654234336e-11 > Line search: gnorm after quadratic fit 6.276152857499e+03 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.418274035925e+03 lambda=5.0000000000000003e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 4.785345842563e+02 lambda=2.5000000000000001e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 2.665412152699e+02 lambda=8.0607289886479045e-03 > Line search: Cubically determined step, current gnorm 2.499109739904e+02 lambda=8.0607289886479045e-04 > 48 SNES Function norm 2.499109739904e+02 > 0 KSP Residual norm 1.339756751889e+01 > 1 KSP Residual norm 2.559175980945e-13 > Line search: gnorm after quadratic fit 6.052259901869e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 3.217431518450e+02 lambda=5.0000000000000003e-02 > Line search: Cubically determined step, current gnorm 2.496541765916e+02 lambda=7.0239599632283649e-03 > 49 SNES Function norm 2.496541765916e+02 > 0 KSP Residual norm 5.340771873687e+00 > 1 KSP Residual norm 1.207454778077e-13 > Line search: gnorm after quadratic fit 2.760767095070e+02 > Line search: Cubically determined step, current gnorm 2.491630276458e+02 lambda=5.0000000000000003e-02 > 50 SNES Function norm 2.491630276458e+02 > > > On Sat, Aug 26, 2017 at 11:45 PM, Barry Smith wrote: > > > On Aug 26, 2017, at 10:43 PM, zakaryah . wrote: > > > > Hi Barry - many thanks for taking the time to understand my many problems and providing so much help. > > > > The reason I was concerned that I could not alter the linesearch was when I tried to use bt instead of the L-BFGS default, cp, the code crashed with an error like "Could not get Jacobian". Maybe this is an incompatibility like you say, since L-BFGS only uses the initial Jacobian and I never tried setting the scale type. > > > > I took your advice and tried to shrink the problem. First I tried shrinking by a factor 1000 but this converged very quickly with all test data I could provide, including the data which was problematic with the large grid. So I settled for a reduction in size by a factor 125. The grid size is 13,230. This is a decent test case because the solver fails to converge with the options I was using before, and it is small enough that I can run it with the options you suggested (-snes_fd_color -snes_type newtonls -snes_monitor -snes_linesearch_monitor -ksp_monitor -pc_type lu). > > > > The output is 1800 lines long - how shall I share it? > > Just email it, that is small enough for email. > > Barry > > > > > > > > > > > On Sat, Aug 26, 2017 at 7:38 PM, Barry Smith wrote: > > > > > On Aug 26, 2017, at 5:56 PM, zakaryah . wrote: > > > > > > I'm using PETSc's SNES methods to solve PDEs which result from Euler-Lagrange equations for the strain energy of a 3D displacement field. There is an additional term in the Lagrangian which describes external forces which arise from various data sets, and that term contains nonlinearities (field terms higher than linear). The grid has about 1.6e6 elements, and the displacement field has 3 components at each grid element. > > > > > > I'm trying to solve a sequence of successively more complicated equations, and the latest equation is failing to converge on some data sets. In particular, the methods were successful for the infinitesimal bulk strain (compression) energy, as well as the full infinitesimal strain energy (bulk + shear), but I'm now trying to generalize to the finite strain, as certain data sets are known to result from displacement fields for which the infinitesimal strain is a poor approximation. > > > > > > I'm using a DMDA, closely following example 48, and my preferred solver is L-BFGS. > > > > So you are using ? > > > > -snes_type qn -snes_qn_type lbfgs > > > > > > > > I have read the FAQs "Why is Newton's method not converging??" and "Why is my iterative linear solver not converging??"? which have raised a number of questions: > > > > Quasi Newton methods either don't use Jacobians or use only the initial Jacobian (the idea behind quasi-Newton methods is to approximate Jacobian information from previous iterations without having the user compute a Jacobian at each iteration). With PETSc's qn it only uses the Jacobian if you use the option > > > > -snes_qn_scale_type Jacobian > > > > otherwise the Jacobian is never computed or used > > > > > > > > > > Is there documentation for the DMDA/SNES methods somewhere? I don't understand these very well. For example, I am not allocating any matrix for the global Jacobian, and I believe this prevents me from changing the line search. If I'm mistaken I would love to see an example of changing the line search type while using DMDA/SNES. > > > > Whether you provide a Jacobian or not is orthogonal to the line search. > > > > You should be able to change the line search with > > > > -snes_linesearch_type bt or nleqerr or basic or l2 or cp > > > > not all of them may work with qn > > > > > > > > > > I don't know how to interpret the linesearch monitor. Even for problems which are converging properly, the linesearch monitor reports "lssucceed=0" on every iteration. Is this a problem? > > > > It returns a 0 if the line search does not believe it has achieved "sufficient decrease" in the function norm (or possibly some other measure of decrease) you should run -snes_linesearch_monitor also with the option -snes_monitor to see what is happening to the function norm > > > > For qn you can add the option > > > > -snes_qn_monitor > > > > to get more detailed monitoring > > > > > > > > > > I'm also having trouble understanding the methods for troubleshooting. I suspect that I've made an error in the analytical Jacobian, which has a rather large number of non-zero elements, but I have no idea how to use -snes_type test -snes_test_display. The FAQs mention that some troubleshooting tools are more useful for small test problems. How small is small? > > > > Tiny, at most a few dozen rows and columns in the Jacobin. > > > > You should run without the -snes_test_display information, what does it say? Does it indicate the Jacobian or report there is likely a problem? > > > > With DMDA you can also use -snes_fd_color to have PETSc compute the Jacobian for you instead of using your analytical form. If it works with this, but not your Jacobian then your Jacobian is wrong. > > > > > When I try to run the program with -snes_type test -snes_test_display, I get errors like: > > > > > > [0]PETSC ERROR: Argument out of range [0]PETSC ERROR: Local index 1076396032 too large 4979879 (max) at 0 > > > > > > The second size is 1 less than the number of field elements, while the first number seems too large for any aspect of the problem - the Jacobian has at most 59 non-zero columns per row. > > > > > > Because I suspect a possible error in the Jacobian, I ran with -snes_mf_operator -pc_type ksp -ksp_ksp_rtol 1e-12 and observed very similar failure to converge (diverging residual) as with the explicit Jacobian. > > > > What do you get with -ksp_monitor -ksp_ksp_monitor it sounds like the true Jacobian is either very ill-conditioned or your function evaluation is wrong. > > > > > Do I need to set an SNES method which is somehow compatible with the "matrix-free" approach? If I instead use -snes_mf, the problem seems to converge, but horrendously slowly (true residual relative decrease by about 1e-5 per iteration). I suppose this supports my suspicion that the Jacobian is incorrect but doesn't really suggest a solution. > > > > > > Is it possible that the analytical Jacobian is correct, but somehow pathological, which causes the SNES to diverge? > > > > Yes > > > > > Neither the Jacobian nor the function have singularities. > > > > > > Thanks for any help you can provide! > > > > Try really hard to set up a small problem (like just use a very coarse grid) to experiment with as you try to get convergence. Using a big problem for debugging convergence is a recipe for pain. > > > > Also since you have a Jacobian I would start with -snes_fd_color -snes_type ls -snes_monitor -snes_linesearch_monitor -ksp_monitor -pc_type lu (not on a huge problem), what happens? Send the output > > > > Barry > > > > > > > > From zakaryah at gmail.com Sat Aug 26 22:55:05 2017 From: zakaryah at gmail.com (zakaryah .) Date: Sat, 26 Aug 2017 23:55:05 -0400 Subject: [petsc-users] A number of questions about DMDA with SNES and Quasi-Newton methods In-Reply-To: <7EE84495-4346-4BFB-B9AD-BCAA3C722461@mcs.anl.gov> References: <020DAED9-AAAD-4741-976B-BB2EF6C79D3F@mcs.anl.gov> <5BF530F6-8D79-47E6-B2C5-B0702FF2AA59@mcs.anl.gov> <7EE84495-4346-4BFB-B9AD-BCAA3C722461@mcs.anl.gov> Message-ID: Yes, except I changed "-snes_type ls" to "-snes_type newtonls" because PETSc complained that ls wasn't a known method. On Sat, Aug 26, 2017 at 11:52 PM, Barry Smith wrote: > > My exact options did you run with? > > > On Aug 26, 2017, at 10:48 PM, zakaryah . wrote: > > > > Here's the output, from the data set which does not converge with l-bfgs: > > > > 0 SNES Function norm 1.370293318432e+04 > > 0 KSP Residual norm 7.457506389218e+02 > > 1 KSP Residual norm 2.244764079994e-10 > > Line search: gnorm after quadratic fit 6.541298279196e+05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 8.963717927372e+04 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.788909416707e+04 lambda=2.5000000000000001e-02 > > Line search: Cubically determined step, current gnorm > 1.340565762719e+04 lambda=1.2500000000000001e-02 > > 1 SNES Function norm 1.340565762719e+04 > > 0 KSP Residual norm 4.096066553372e+02 > > 1 KSP Residual norm 3.313671167444e-11 > > Line search: gnorm after quadratic fit 1.113749573695e+06 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.406390140546e+05 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.126781917443e+04 lambda=2.5000000000000001e-02 > > Line search: Cubically determined step, current gnorm > 1.272988597973e+04 lambda=1.2500000000000001e-02 > > 2 SNES Function norm 1.272988597973e+04 > > 0 KSP Residual norm 8.291344597817e+01 > > 1 KSP Residual norm 7.182258362182e-12 > > Line search: gnorm after quadratic fit 1.121913743889e+04 > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > 3 SNES Function norm 1.121913743889e+04 > > 0 KSP Residual norm 6.830535877014e+01 > > 1 KSP Residual norm 3.629826411580e-12 > > Line search: gnorm after quadratic fit 9.966344973786e+03 > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > 4 SNES Function norm 9.966344973786e+03 > > 0 KSP Residual norm 5.137691531345e+01 > > 1 KSP Residual norm 1.954502098181e-12 > > Line search: gnorm after quadratic fit 8.905508641232e+03 > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > 5 SNES Function norm 8.905508641232e+03 > > 0 KSP Residual norm 4.295019262963e+01 > > 1 KSP Residual norm 1.581527994925e-12 > > Line search: gnorm after quadratic fit 7.599173694189e+03 > > Line search: Quadratically determined step, > lambda=1.4157226463489950e-01 > > 6 SNES Function norm 7.599173694189e+03 > > 0 KSP Residual norm 3.520472291520e+01 > > 1 KSP Residual norm 1.169994130568e-12 > > Line search: gnorm after quadratic fit 6.797214843928e+03 > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > 7 SNES Function norm 6.797214843928e+03 > > 0 KSP Residual norm 2.683523206056e+01 > > 1 KSP Residual norm 9.039858014119e-13 > > Line search: gnorm after quadratic fit 6.098038917364e+03 > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > 8 SNES Function norm 6.098038917364e+03 > > 0 KSP Residual norm 2.300710560681e+01 > > 1 KSP Residual norm 1.010402303464e-12 > > Line search: gnorm after quadratic fit 5.486151385552e+03 > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > 9 SNES Function norm 5.486151385552e+03 > > 0 KSP Residual norm 2.824628827619e+01 > > 1 KSP Residual norm 1.009589866569e-12 > > Line search: gnorm after quadratic fit 4.964991021247e+03 > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > 10 SNES Function norm 4.964991021247e+03 > > 0 KSP Residual norm 6.285926028595e+01 > > 1 KSP Residual norm 2.833546214180e-12 > > Line search: gnorm after quadratic fit 2.100041391472e+04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.804051080767e+03 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm > 4.893296169579e+03 lambda=2.5000000000000001e-02 > > 11 SNES Function norm 4.893296169579e+03 > > 0 KSP Residual norm 1.688978282804e+01 > > 1 KSP Residual norm 5.927677470786e-13 > > Line search: gnorm after quadratic fit 4.400894622431e+03 > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > 12 SNES Function norm 4.400894622431e+03 > > 0 KSP Residual norm 1.481197699600e+01 > > 1 KSP Residual norm 4.522572128105e-13 > > Line search: Using full step: fnorm 4.400894622431e+03 gnorm > 2.094971849007e+03 > > 13 SNES Function norm 2.094971849007e+03 > > 0 KSP Residual norm 3.514164563318e+00 > > 1 KSP Residual norm 3.022385947499e-13 > > Line search: gnorm after quadratic fit 1.687641025382e+03 > > Line search: Quadratically determined step, > lambda=2.0307116693368590e-01 > > 14 SNES Function norm 1.687641025382e+03 > > 0 KSP Residual norm 2.138591884686e+00 > > 1 KSP Residual norm 4.023500814078e-14 > > Line search: Using full step: fnorm 1.687641025382e+03 gnorm > 1.131934218470e+03 > > 15 SNES Function norm 1.131934218470e+03 > > 0 KSP Residual norm 3.245035110327e+00 > > 1 KSP Residual norm 1.293626215269e-13 > > Line search: Using full step: fnorm 1.131934218470e+03 gnorm > 7.340573607307e+02 > > 16 SNES Function norm 7.340573607307e+02 > > 0 KSP Residual norm 1.957698957904e+00 > > 1 KSP Residual norm 3.444648967078e-13 > > Line search: Using full step: fnorm 7.340573607307e+02 gnorm > 5.024723505168e+02 > > 17 SNES Function norm 5.024723505168e+02 > > 0 KSP Residual norm 2.510538703839e+00 > > 1 KSP Residual norm 8.570440675253e-14 > > Line search: gnorm after quadratic fit 4.548776456608e+02 > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > 18 SNES Function norm 4.548776456608e+02 > > 0 KSP Residual norm 6.741705718178e-01 > > 1 KSP Residual norm 1.650556120809e-14 > > Line search: Using full step: fnorm 4.548776456608e+02 gnorm > 1.351189086642e+02 > > 19 SNES Function norm 1.351189086642e+02 > > 0 KSP Residual norm 7.653741241950e+00 > > 1 KSP Residual norm 8.326848236950e-14 > > Line search: gnorm after quadratic fit 4.215455105006e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.889750369356e+02 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.358691836999e+02 lambda=1.0303015930243279e-02 > > Line search: Cubically determined step, current gnorm > 1.348911963390e+02 lambda=3.5279526770504110e-03 > > 20 SNES Function norm 1.348911963390e+02 > > 0 KSP Residual norm 4.209281176918e+00 > > 1 KSP Residual norm 1.233232881375e-13 > > Line search: gnorm after quadratic fit 1.860023264470e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.413911132196e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm > 1.339597869053e+02 lambda=1.5787957598629023e-02 > > 21 SNES Function norm 1.339597869053e+02 > > 0 KSP Residual norm 1.718484765841e+00 > > 1 KSP Residual norm 6.666016296543e-14 > > Line search: gnorm after quadratic fit 1.326878521472e+02 > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > 22 SNES Function norm 1.326878521472e+02 > > 0 KSP Residual norm 1.515373499919e+00 > > 1 KSP Residual norm 2.259154130795e-12 > > Line search: gnorm after quadratic fit 1.226907316391e+02 > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > 23 SNES Function norm 1.226907316391e+02 > > 0 KSP Residual norm 1.080252936903e+00 > > 1 KSP Residual norm 1.847020526683e-14 > > Line search: gnorm after quadratic fit 1.163632111851e+02 > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > 24 SNES Function norm 1.163632111851e+02 > > 0 KSP Residual norm 2.491746958382e+00 > > 1 KSP Residual norm 6.389134193637e-14 > > Line search: gnorm after quadratic fit 1.345487153563e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.169738363622e+02 lambda=4.4108900954515480e-02 > > Line search: Cubically determined step, current gnorm > 1.152177638108e+02 lambda=1.9997442889243631e-02 > > 25 SNES Function norm 1.152177638108e+02 > > 0 KSP Residual norm 5.364385501004e+00 > > 1 KSP Residual norm 8.457149562463e-14 > > Line search: gnorm after quadratic fit 2.722095758964e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.480946353374e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm > 1.150680255994e+02 lambda=6.3560128131639167e-03 > > 26 SNES Function norm 1.150680255994e+02 > > 0 KSP Residual norm 4.302025268263e+00 > > 1 KSP Residual norm 1.017526937941e-13 > > Line search: gnorm after quadratic fit 1.956300983573e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.318600522939e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm > 1.147123505014e+02 lambda=7.6060788653548803e-03 > > 27 SNES Function norm 1.147123505014e+02 > > 0 KSP Residual norm 6.195463111324e+00 > > 1 KSP Residual norm 1.235283250361e-13 > > Line search: gnorm after quadratic fit 3.324821547049e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.612593208504e+02 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.147389525772e+02 lambda=6.1750939181374294e-03 > > Line search: Cubically determined step, current gnorm > 1.145411432123e+02 lambda=3.0078592586792975e-03 > > 28 SNES Function norm 1.145411432123e+02 > > 0 KSP Residual norm 1.454704250187e+01 > > 1 KSP Residual norm 2.368485174123e-13 > > Line search: gnorm after quadratic fit 1.216293873116e+03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.796524621727e+02 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.359314163651e+02 lambda=1.4867675803955788e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.146009802557e+02 lambda=1.4867675803955788e-03 > > Line search: Cubically determined step, current gnorm > 1.145096815033e+02 lambda=5.5250912472932839e-04 > > 29 SNES Function norm 1.145096815033e+02 > > 0 KSP Residual norm 3.430451345093e+01 > > 1 KSP Residual norm 1.069396165938e-12 > > Line search: gnorm after quadratic fit 1.161329407098e+04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.260690718050e+03 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.696806489042e+02 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.960149915648e+02 lambda=1.1276129246469476e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.158113641658e+02 lambda=1.5873910451430554e-03 > > Line search: Cubically determined step, current gnorm > 1.145062232916e+02 lambda=1.5873910451430555e-04 > > 30 SNES Function norm 1.145062232916e+02 > > 0 KSP Residual norm 2.662578971526e+01 > > 1 KSP Residual norm 5.464011789728e-13 > > Line search: gnorm after quadratic fit 4.375119254490e+03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.038018103928e+03 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.169328002874e+02 lambda=2.3789161387159519e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.262835432714e+02 lambda=5.9737415571960795e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.145626045197e+02 lambda=5.9737415571960802e-04 > > Line search: Cubically determined step, current gnorm > 1.144968604079e+02 lambda=1.6421773527706333e-04 > > 31 SNES Function norm 1.144968604079e+02 > > 0 KSP Residual norm 6.322033697338e+01 > > 1 KSP Residual norm 1.507157991448e-12 > > Line search: gnorm after quadratic fit 5.809243699277e+04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 9.460487584142e+03 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.893183483197e+03 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.960337007072e+02 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.771527792790e+02 lambda=5.3912931685137378e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.150137639707e+02 lambda=5.3912931685137376e-04 > > Line search: Cubically determined step, current gnorm > 1.144964484571e+02 lambda=5.3912931685137380e-05 > > 32 SNES Function norm 1.144964484571e+02 > > 0 KSP Residual norm 3.859510930996e+01 > > 1 KSP Residual norm 8.069118044382e-13 > > Line search: gnorm after quadratic fit 1.106329930525e+04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.155884463041e+03 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.933963819094e+02 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.849629797377e+02 lambda=9.7744286136270241e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.150857687050e+02 lambda=9.7744286136270254e-04 > > Line search: Cubically determined step, current gnorm > 1.144922906340e+02 lambda=9.7744286136270254e-05 > > 33 SNES Function norm 1.144922906340e+02 > > 0 KSP Residual norm 4.952038022394e+01 > > 1 KSP Residual norm 7.460263245424e-13 > > Line search: gnorm after quadratic fit 3.005091127220e+04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.229308416025e+03 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.138600794682e+03 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.390856262238e+02 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.394997214983e+02 lambda=4.4582997750629580e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.146836358799e+02 lambda=4.4582997750629581e-04 > > Line search: Cubically determined step, current gnorm > 1.144895966587e+02 lambda=4.7644082443915877e-05 > > 34 SNES Function norm 1.144895966587e+02 > > 0 KSP Residual norm 1.146914786457e+02 > > 1 KSP Residual norm 4.791627042400e-12 > > Line search: gnorm after quadratic fit 2.601294145944e+05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.324148513778e+04 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.247478406023e+03 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.200340900661e+03 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.696223112300e+02 lambda=6.1514413845115794e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.342365431983e+02 lambda=1.7502929694284564e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.146686063035e+02 lambda=1.7502929694284566e-04 > > Line search: Cubically determined step, current gnorm > 1.144895868489e+02 lambda=1.7502929694284566e-05 > > 35 SNES Function norm 1.144895868489e+02 > > 0 KSP Residual norm 6.311017209658e+01 > > 1 KSP Residual norm 8.384445939117e-13 > > Line search: gnorm after quadratic fit 5.781533400572e+04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 9.419557746031e+03 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.886081770030e+03 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.945810143740e+02 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.767820854837e+02 lambda=5.3859001959289735e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.150034040559e+02 lambda=5.3859001959289732e-04 > > Line search: Cubically determined step, current gnorm > 1.144891501665e+02 lambda=5.3859001959289732e-05 > > 36 SNES Function norm 1.144891501665e+02 > > 0 KSP Residual norm 3.880748384332e+01 > > 1 KSP Residual norm 6.400339290453e-13 > > Line search: gnorm after quadratic fit 1.122504184426e+04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.180728237366e+03 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.987870621566e+02 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.863711604331e+02 lambda=9.8150771384688824e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.150916783781e+02 lambda=9.8150771384688824e-04 > > Line search: Cubically determined step, current gnorm > 1.144850837411e+02 lambda=9.8150771384688832e-05 > > 37 SNES Function norm 1.144850837411e+02 > > 0 KSP Residual norm 4.811537498557e+01 > > 1 KSP Residual norm 9.738167670242e-13 > > Line search: gnorm after quadratic fit 2.784098355218e+04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.885118868254e+03 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.074843354348e+03 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.255202820836e+02 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.365202996130e+02 lambda=4.3204204582016374e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.146504919412e+02 lambda=4.3204204582016374e-04 > > Line search: Cubically determined step, current gnorm > 1.144822306241e+02 lambda=5.0376546850227848e-05 > > 38 SNES Function norm 1.144822306241e+02 > > 0 KSP Residual norm 1.120914002482e+02 > > 1 KSP Residual norm 5.452125292284e-12 > > Line search: gnorm after quadratic fit 2.427186680567e+05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.112196656857e+04 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.967397366072e+03 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.149551659770e+03 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.529630886791e+02 lambda=6.0885216927030559e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.315267519231e+02 lambda=1.6656233536183130e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.146353659250e+02 lambda=1.6656233536183130e-04 > > Line search: Cubically determined step, current gnorm > 1.144820487391e+02 lambda=1.6656233536183130e-05 > > 39 SNES Function norm 1.144820487391e+02 > > 0 KSP Residual norm 7.182416170980e+01 > > 1 KSP Residual norm 1.292147133333e-12 > > Line search: gnorm after quadratic fit 8.255331293322e+04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.302939895170e+04 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.501228089911e+03 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.185010378583e+02 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.088179821424e+02 lambda=5.7489510178867142e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.168272901121e+02 lambda=9.7452649444612811e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.144951972300e+02 lambda=9.7452649444612822e-05 > > Line search: Cubically determined step, current gnorm > 1.144807676687e+02 lambda=2.2399506502463798e-05 > > 40 SNES Function norm 1.144807676687e+02 > > 0 KSP Residual norm 1.728679810285e+02 > > 1 KSP Residual norm 3.878068639716e-12 > > Line search: gnorm after quadratic fit 9.011020578535e+05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.111818830011e+05 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.504789858103e+04 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.754312133162e+03 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.212492111975e+02 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.199969180537e+02 lambda=2.6424184504193135e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.154794639440e+02 lambda=2.6424184504193136e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.144880673342e+02 lambda=2.6424184504193136e-05 > > Line search: Cubically determined step, current gnorm > 1.144805461570e+02 lambda=3.8712107591125690e-06 > > 41 SNES Function norm 1.144805461570e+02 > > 0 KSP Residual norm 4.162780846202e+02 > > 1 KSP Residual norm 1.732341544934e-11 > > Line search: gnorm after quadratic fit 1.355673864369e+07 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.747523002884e+06 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.342205048417e+05 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.425635699680e+04 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.882150659178e+03 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.259664786336e+03 lambda=3.1250000000000002e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.653670676209e+02 lambda=1.5625000000000001e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.453655830144e+02 lambda=5.8237455565260388e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.147659525018e+02 lambda=5.8237455565260393e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.144827915995e+02 lambda=5.8237455565260400e-06 > > Line search: Cubically determined step, current gnorm > 1.144805080017e+02 lambda=6.6689295146509104e-07 > > 42 SNES Function norm 1.144805080017e+02 > > 0 KSP Residual norm 1.004135512581e+03 > > 1 KSP Residual norm 3.867626041000e-09 > > Line search: gnorm after quadratic fit 1.832578994882e+08 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.269698278878e+07 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.792476589915e+06 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.420660371083e+05 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.321686926168e+04 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.548358078234e+03 lambda=3.1250000000000002e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.429504802276e+03 lambda=1.5625000000000001e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.317723385004e+02 lambda=7.8125000000000004e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.460079723095e+02 lambda=2.5078917343692407e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.147908977725e+02 lambda=2.5078917343692408e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.144833604238e+02 lambda=2.5078917343692412e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.144805106824e+02 lambda=2.5078917343692411e-07 > > Line search: Cubically determined step, current gnorm > 1.144805014337e+02 lambda=1.1468707119027746e-07 > > 43 SNES Function norm 1.144805014337e+02 > > 0 KSP Residual norm 2.418614573592e+03 > > 1 KSP Residual norm 6.085078742847e-10 > > Line search: gnorm after quadratic fit 2.598476259775e+09 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.262759415873e+08 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.116845970403e+07 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.250465130250e+06 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.863493884574e+05 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 9.501468163771e+04 lambda=3.1250000000000002e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.482658980483e+04 lambda=1.5625000000000001e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.802395557883e+03 lambda=7.8125000000000004e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.788149582374e+02 lambda=3.9062500000000002e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.248828337038e+02 lambda=1.8333058767960295e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.186285836222e+02 lambda=3.7550993478654105e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.145209710139e+02 lambda=3.7550993478654107e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.144808670668e+02 lambda=3.7550993478654111e-07 > > Line search: Cubically determined step, current gnorm > 1.144805012252e+02 lambda=3.7550993478654114e-08 > > 44 SNES Function norm 1.144805012252e+02 > > 0 KSP Residual norm 1.432476672735e+03 > > 1 KSP Residual norm 7.850524783892e-11 > > Line search: gnorm after quadratic fit 5.336191593632e+08 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.625576866625e+07 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 8.181408387845e+06 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.003310644422e+06 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.236384273292e+05 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.658430638069e+04 lambda=3.1250000000000002e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.977463068161e+03 lambda=1.5625000000000001e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.674238499253e+02 lambda=7.8125000000000004e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.333616820791e+02 lambda=3.3764776729281175e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.161349153752e+02 lambda=4.0497161764116874e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.144966925969e+02 lambda=4.0497161764116874e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.144806214839e+02 lambda=4.0497161764116878e-07 > > Line search: Cubically determined step, current gnorm > 1.144804979966e+02 lambda=5.6339112427782378e-08 > > 45 SNES Function norm 1.144804979966e+02 > > 0 KSP Residual norm 3.453401579761e+03 > > 1 KSP Residual norm 4.197968028126e-09 > > Line search: gnorm after quadratic fit 7.554006183767e+09 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 9.471974940372e+08 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.191613865049e+08 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.509784334249e+07 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.943752478560e+06 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.597601716755e+05 lambda=3.1250000000000002e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.775572331075e+04 lambda=1.5625000000000001e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.418045407608e+03 lambda=7.8125000000000004e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.357066758731e+03 lambda=3.9062500000000002e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.859267839080e+02 lambda=1.9531250000000001e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.501494912160e+02 lambda=7.5160826909319168e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.148144926477e+02 lambda=7.5160826909319171e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.144837498478e+02 lambda=7.5160826909319179e-07 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.144805227746e+02 lambda=7.5160826909319182e-08 > > Line search: Cubically determined step, current gnorm > 1.144804974438e+02 lambda=9.6864021663644795e-09 > > 46 SNES Function norm 1.144804974438e+02 > > 0 KSP Residual norm 8.345139428850e+03 > > 1 KSP Residual norm 1.027819754739e-09 > > Line search: gnorm after quadratic fit 1.061319903906e+11 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.325012985379e+10 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.652236226640e+09 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.055533971630e+08 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.546607716763e+07 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.134442858835e+06 lambda=3.1250000000000002e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.839168570687e+05 lambda=1.5625000000000001e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.830568178626e+04 lambda=7.8125000000000004e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.201776786081e+03 lambda=3.9062500000000002e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.540520468013e+03 lambda=1.9531250000000001e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.573504890506e+02 lambda=9.7656250000000005e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.516203908013e+02 lambda=3.2703670177372021e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.148480075676e+02 lambda=3.2703670177372022e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.144841475328e+02 lambda=3.2703670177372023e-07 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.144805305720e+02 lambda=3.2703670177372021e-08 > > Line search: Cubically determined step, current gnorm > 1.144804974367e+02 lambda=3.2703670177372025e-09 > > 47 SNES Function norm 1.144804974367e+02 > > 0 KSP Residual norm 4.668983500382e+03 > > 1 KSP Residual norm 1.398997665317e-09 > > Line search: gnorm after quadratic fit 1.865309565532e+10 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.336975299727e+09 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.934905088739e+08 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.704520478641e+07 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.728477809448e+06 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.193001670096e+05 lambda=3.1250000000000002e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 8.610673238239e+04 lambda=1.5625000000000001e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.354711683605e+04 lambda=7.8125000000000004e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.589557246433e+03 lambda=3.9062500000000002e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.367851970709e+02 lambda=1.9531250000000001e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.136930269795e+02 lambda=9.0316845802227864e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.172186635069e+02 lambda=1.5831613287181393e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.145074017254e+02 lambda=1.5831613287181394e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.144807499816e+02 lambda=1.5831613287181396e-07 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.144804983345e+02 lambda=1.5831613287181397e-08 > > Line search: Cubically determined step, current gnorm > 1.144804971346e+02 lambda=5.2932921109871310e-09 > > 48 SNES Function norm 1.144804971346e+02 > > 0 KSP Residual norm 1.132678078317e+04 > > 1 KSP Residual norm 2.477518733314e-10 > > Line search: gnorm after quadratic fit 2.654659022365e+11 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.315296223725e+10 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.136635677074e+09 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.152507060235e+08 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.397060094478e+07 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.898362012287e+06 lambda=3.1250000000000002e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 9.685179520906e+05 lambda=1.5625000000000001e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.194040779842e+05 lambda=7.8125000000000004e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.606415730227e+04 lambda=3.9062500000000002e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.902698091972e+03 lambda=1.9531250000000001e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.521549384652e+02 lambda=9.7656250000000005e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.288999778994e+02 lambda=4.1899746703195281e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.157880829786e+02 lambda=4.5470218451893824e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.144935741206e+02 lambda=4.5470218451893828e-07 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.144806232638e+02 lambda=4.5470218451893831e-08 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.144804979250e+02 lambda=4.5470218451893835e-09 > > Line search: Cubically determined step, current gnorm > 1.144804970825e+02 lambda=9.0293679903918216e-10 > > 49 SNES Function norm 1.144804970825e+02 > > 0 KSP Residual norm 2.712544829144e+04 > > 1 KSP Residual norm 4.949246309677e-09 > > Line search: gnorm after quadratic fit 3.650846005745e+12 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.565321055911e+11 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.711080201118e+10 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.150022242308e+09 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 8.965954117985e+08 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.128096393645e+08 lambda=3.1250000000000002e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.429702091584e+07 lambda=1.5625000000000001e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.841819946536e+06 lambda=7.8125000000000004e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.465032956946e+05 lambda=3.9062500000000002e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.594210253794e+04 lambda=1.9531250000000001e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.141110278944e+03 lambda=9.7656250000000005e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.306952279045e+03 lambda=4.8828125000000003e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.754164864338e+02 lambda=2.4414062500000001e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.476861367158e+02 lambda=9.2451761406722810e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.147929263780e+02 lambda=9.2451761406722810e-07 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.144836022952e+02 lambda=9.2451761406722821e-08 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.144805271860e+02 lambda=9.2451761406722831e-09 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.144804972895e+02 lambda=9.2451761406722839e-10 > > Line search: Cubically determined step, current gnorm > 1.144804970737e+02 lambda=1.5633616333063305e-10 > > 50 SNES Function norm 1.144804970737e+02 > > 0 SNES Function norm 2.308693894796e+03 > > 0 KSP Residual norm 8.981999720532e+00 > > 1 KSP Residual norm 2.363170936183e-13 > > Line search: Using full step: fnorm 2.308693894796e+03 gnorm > 7.571661187318e+02 > > 1 SNES Function norm 7.571661187318e+02 > > 0 KSP Residual norm 2.149614048903e+00 > > 1 KSP Residual norm 9.511247057888e-13 > > Line search: Using full step: fnorm 7.571661187318e+02 gnorm > 4.450081004997e+02 > > 2 SNES Function norm 4.450081004997e+02 > > 0 KSP Residual norm 1.706469075123e+01 > > 1 KSP Residual norm 5.803815175472e-13 > > Line search: gnorm after quadratic fit 1.510518198899e+03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.850796532980e+02 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.515983139755e+02 lambda=2.0602556887689423e-02 > > Line search: Cubically determined step, current gnorm > 4.434800867235e+02 lambda=8.2396279492937211e-03 > > 3 SNES Function norm 4.434800867235e+02 > > 0 KSP Residual norm 3.208587171626e+00 > > 1 KSP Residual norm 1.099072610659e-13 > > Line search: gnorm after quadratic fit 4.080637194736e+02 > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > 4 SNES Function norm 4.080637194736e+02 > > 0 KSP Residual norm 8.136557176540e+00 > > 1 KSP Residual norm 8.800137844173e-13 > > Line search: gnorm after quadratic fit 5.261656549654e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.131114070934e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm > 4.031614746044e+02 lambda=2.4674842039461482e-02 > > 5 SNES Function norm 4.031614746044e+02 > > 0 KSP Residual norm 7.609918907567e+00 > > 1 KSP Residual norm 1.613159932655e-13 > > Line search: gnorm after quadratic fit 5.353908064984e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.110480554132e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm > 3.991168240716e+02 lambda=2.3079500036735322e-02 > > 6 SNES Function norm 3.991168240716e+02 > > 0 KSP Residual norm 3.800845472041e+00 > > 1 KSP Residual norm 4.841682188278e-13 > > Line search: gnorm after quadratic fit 3.787886582952e+02 > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > 7 SNES Function norm 3.787886582952e+02 > > 0 KSP Residual norm 1.892621919219e+00 > > 1 KSP Residual norm 3.576655371800e-12 > > Line search: gnorm after quadratic fit 3.440181918909e+02 > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > 8 SNES Function norm 3.440181918909e+02 > > 0 KSP Residual norm 3.559759789147e+00 > > 1 KSP Residual norm 8.347521826622e-13 > > Line search: gnorm after quadratic fit 3.287993515195e+02 > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > 9 SNES Function norm 3.287993515195e+02 > > 0 KSP Residual norm 1.825073540507e+00 > > 1 KSP Residual norm 8.352745008123e-14 > > Line search: Using full step: fnorm 3.287993515195e+02 gnorm > 2.710650507416e+02 > > 10 SNES Function norm 2.710650507416e+02 > > 0 KSP Residual norm 7.568432945608e-01 > > 1 KSP Residual norm 2.780715252274e-14 > > Line search: Using full step: fnorm 2.710650507416e+02 gnorm > 1.513359047342e+02 > > 11 SNES Function norm 1.513359047342e+02 > > 0 KSP Residual norm 9.387460484575e+00 > > 1 KSP Residual norm 7.091233040676e-13 > > Line search: gnorm after quadratic fit 3.998857979851e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.060972049714e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm > 1.512140169420e+02 lambda=5.4338709720680610e-03 > > 12 SNES Function norm 1.512140169420e+02 > > 0 KSP Residual norm 4.399424360499e+00 > > 1 KSP Residual norm 1.614362118182e-13 > > Line search: gnorm after quadratic fit 1.913552832643e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.559719302467e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm > 1.499985374733e+02 lambda=1.7102027220313589e-02 > > 13 SNES Function norm 1.499985374733e+02 > > 0 KSP Residual norm 3.740397849742e+00 > > 1 KSP Residual norm 8.986775577006e-13 > > Line search: gnorm after quadratic fit 1.764118876632e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.522381536119e+02 lambda=4.8196830215713270e-02 > > Line search: Cubically determined step, current gnorm > 1.486175880390e+02 lambda=1.8881300948189364e-02 > > 14 SNES Function norm 1.486175880390e+02 > > 0 KSP Residual norm 6.067973818528e+00 > > 1 KSP Residual norm 4.527845229549e-13 > > Line search: gnorm after quadratic fit 2.514021299115e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.679972156573e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm > 1.481015724304e+02 lambda=9.0116621678703428e-03 > > 15 SNES Function norm 1.481015724304e+02 > > 0 KSP Residual norm 6.108754994263e+00 > > 1 KSP Residual norm 2.557635976440e-13 > > Line search: gnorm after quadratic fit 2.458081150104e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.681837029397e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm > 1.476148340442e+02 lambda=7.9580911933571953e-03 > > 16 SNES Function norm 1.476148340442e+02 > > 0 KSP Residual norm 7.914946163932e+00 > > 1 KSP Residual norm 1.512066885699e-13 > > Line search: gnorm after quadratic fit 3.458938604598e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.883018868359e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm > 1.474286108114e+02 lambda=6.7262521208543979e-03 > > 17 SNES Function norm 1.474286108114e+02 > > 0 KSP Residual norm 5.285449532689e+00 > > 1 KSP Residual norm 6.693733977456e-12 > > Line search: gnorm after quadratic fit 2.170263102661e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.607560548008e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm > 1.467785507822e+02 lambda=9.9244383205188240e-03 > > 18 SNES Function norm 1.467785507822e+02 > > 0 KSP Residual norm 8.124903695635e+00 > > 1 KSP Residual norm 2.322439601127e-11 > > Line search: gnorm after quadratic fit 3.589716592364e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.907315184877e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm > 1.466341888638e+02 lambda=6.5538271222582893e-03 > > 19 SNES Function norm 1.466341888638e+02 > > 0 KSP Residual norm 5.253550718343e+00 > > 1 KSP Residual norm 1.575657996883e-12 > > Line search: gnorm after quadratic fit 2.155795776725e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.598564001687e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm > 1.459869404602e+02 lambda=9.9195822632931301e-03 > > 20 SNES Function norm 1.459869404602e+02 > > 0 KSP Residual norm 8.405987790193e+00 > > 1 KSP Residual norm 2.046159481178e-13 > > Line search: gnorm after quadratic fit 3.767908298426e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.941885062002e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm > 1.458995232755e+02 lambda=6.4359684554015136e-03 > > 21 SNES Function norm 1.458995232755e+02 > > 0 KSP Residual norm 5.036348246593e+00 > > 1 KSP Residual norm 3.645081669075e-13 > > Line search: gnorm after quadratic fit 2.083222977519e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.575737508694e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm > 1.452039802458e+02 lambda=1.0554092389542354e-02 > > 22 SNES Function norm 1.452039802458e+02 > > 0 KSP Residual norm 8.562292355998e+00 > > 1 KSP Residual norm 3.256332645483e-13 > > Line search: gnorm after quadratic fit 3.869470823355e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.959483128249e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm > 1.451523830598e+02 lambda=6.3780526507799607e-03 > > 23 SNES Function norm 1.451523830598e+02 > > 0 KSP Residual norm 4.919667503862e+00 > > 1 KSP Residual norm 4.823931177115e-13 > > Line search: gnorm after quadratic fit 2.042891039525e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.560623102934e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm > 1.444331916523e+02 lambda=1.0890355421223689e-02 > > 24 SNES Function norm 1.444331916523e+02 > > 0 KSP Residual norm 8.727282395369e+00 > > 1 KSP Residual norm 7.090683582186e-13 > > Line search: gnorm after quadratic fit 3.977929422821e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.978556223200e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm > 1.444215965394e+02 lambda=6.3477766966048947e-03 > > 25 SNES Function norm 1.444215965394e+02 > > 0 KSP Residual norm 4.759732971179e+00 > > 1 KSP Residual norm 7.539889498211e-13 > > Line search: gnorm after quadratic fit 1.990589649135e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.542648241555e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm > 1.436629416941e+02 lambda=1.1434720389464151e-02 > > 26 SNES Function norm 1.436629416941e+02 > > 0 KSP Residual norm 8.844861828477e+00 > > 1 KSP Residual norm 4.372001279689e-13 > > Line search: gnorm after quadratic fit 4.055598972133e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.990820671396e+02 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.436827663113e+02 lambda=6.3302081701296859e-03 > > Line search: Cubically determined step, current gnorm > 1.434397789472e+02 lambda=3.1285674619640730e-03 > > 27 SNES Function norm 1.434397789472e+02 > > 0 KSP Residual norm 2.168630760128e+01 > > 1 KSP Residual norm 3.975838928402e-13 > > Line search: gnorm after quadratic fit 1.655681371309e+03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.972331169594e+02 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.804118272840e+02 lambda=1.6710557456633125e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.435928635079e+02 lambda=1.6710557456633126e-03 > > Line search: Cubically determined step, current gnorm > 1.434032742903e+02 lambda=5.1357350159978810e-04 > > 28 SNES Function norm 1.434032742903e+02 > > 0 KSP Residual norm 5.259508821923e+01 > > 1 KSP Residual norm 1.358381204928e-11 > > Line search: gnorm after quadratic fit 1.908330224731e+04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.431279702545e+03 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 8.060945045253e+02 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.791318323447e+02 lambda=1.2124172979783788e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.491140019897e+02 lambda=2.6952165802905347e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.434246250245e+02 lambda=2.6952165802905350e-04 > > Line search: Cubically determined step, current gnorm > 1.433970449422e+02 lambda=8.6980371578986910e-05 > > 29 SNES Function norm 1.433970449422e+02 > > 0 KSP Residual norm 1.326287161615e+02 > > 1 KSP Residual norm 5.692176796134e-12 > > Line search: gnorm after quadratic fit 2.077891749832e+05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.654187989332e+04 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.213029457851e+03 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.001385334742e+03 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.323976827250e+02 lambda=5.9607661619885998e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.489839529892e+02 lambda=1.0476257410701045e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.434396736634e+02 lambda=1.0476257410701046e-04 > > Line search: Cubically determined step, current gnorm > 1.433960671821e+02 lambda=1.3664867646895530e-05 > > 30 SNES Function norm 1.433960671821e+02 > > 0 KSP Residual norm 3.320710360189e+02 > > 1 KSP Residual norm 1.365660123102e-11 > > Line search: gnorm after quadratic fit 3.597335441013e+06 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.714766420450e+05 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.566809766217e+04 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.038660363150e+04 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.026997416957e+03 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.382653551072e+02 lambda=3.1250000000000002e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.071747386385e+02 lambda=1.3384948046761360e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.439693866777e+02 lambda=1.3384948046761360e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.434000505249e+02 lambda=1.3384948046761361e-05 > > Line search: Cubically determined step, current gnorm > 1.433959111179e+02 lambda=2.1771867000079373e-06 > > 31 SNES Function norm 1.433959111179e+02 > > 0 KSP Residual norm 8.385024273664e+02 > > 1 KSP Residual norm 2.688330817732e-11 > > Line search: gnorm after quadratic fit 5.487352481970e+07 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.776642694838e+06 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 8.310551423141e+05 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.023322644608e+05 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.368662233379e+04 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.472194884015e+03 lambda=3.1250000000000002e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.718801059897e+02 lambda=1.5625000000000001e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.274234972424e+02 lambda=6.3064412238487922e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.442194384053e+02 lambda=6.3064412238487925e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.434033578642e+02 lambda=6.3064412238487927e-06 > > Line search: Cubically determined step, current gnorm > 1.433959042208e+02 lambda=6.3064412238487929e-07 > > 32 SNES Function norm 1.433959042208e+02 > > 0 KSP Residual norm 5.310191626867e+02 > > 1 KSP Residual norm 2.270033897601e-10 > > Line search: gnorm after quadratic fit 1.447633783740e+07 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.859761774309e+06 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.472992503503e+05 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.557594026810e+04 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.969012939380e+03 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.269212161982e+03 lambda=3.1250000000000002e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.859005100842e+02 lambda=1.5625000000000001e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.695095262046e+02 lambda=5.4509037994531233e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.436389958907e+02 lambda=5.4509037994531237e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.433976258223e+02 lambda=5.4509037994531242e-06 > > Line search: Cubically determined step, current gnorm > 1.433958431980e+02 lambda=8.5124820362933632e-07 > > 33 SNES Function norm 1.433958431980e+02 > > 0 KSP Residual norm 1.341142541825e+03 > > 1 KSP Residual norm 4.194815344365e-11 > > Line search: gnorm after quadratic fit 2.256410317099e+08 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.797696259877e+07 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.447237377751e+06 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.221898175722e+05 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.260244723327e+04 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.539148524881e+03 lambda=3.1250000000000002e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.558034531173e+03 lambda=1.5625000000000001e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.788188892302e+02 lambda=7.8125000000000004e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.753621043454e+02 lambda=2.4427125599600652e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.437122397600e+02 lambda=2.4427125599600654e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.433986985128e+02 lambda=2.4427125599600655e-06 > > Line search: Cubically determined step, current gnorm > 1.433958402293e+02 lambda=2.4427125599600656e-07 > > 34 SNES Function norm 1.433958402293e+02 > > 0 KSP Residual norm 8.620962950418e+02 > > 1 KSP Residual norm 4.517777375659e-11 > > Line search: gnorm after quadratic fit 6.134442313460e+07 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.790495969255e+06 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.008365220843e+06 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.364572513478e+05 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.037891335918e+04 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.640571521199e+03 lambda=3.1250000000000002e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 8.472549649319e+02 lambda=1.5625000000000001e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.906041216274e+02 lambda=7.6348458761785112e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.504925859329e+02 lambda=1.7740973415567094e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.434632637071e+02 lambda=1.7740973415567094e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.433962847027e+02 lambda=1.7740973415567095e-06 > > Line search: Cubically determined step, current gnorm > 1.433958170795e+02 lambda=3.2293255704969003e-07 > > 35 SNES Function norm 1.433958170795e+02 > > 0 KSP Residual norm 2.177497039945e+03 > > 1 KSP Residual norm 8.546235181505e-11 > > Line search: gnorm after quadratic fit 9.689178330938e+08 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.204850731541e+08 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.491460480376e+07 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.833699292784e+06 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.246639021599e+05 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.860166571872e+04 lambda=3.1250000000000002e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.484329051490e+03 lambda=1.5625000000000001e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.050411687443e+03 lambda=7.8125000000000004e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.488366972009e+02 lambda=3.7767265396089055e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.508326035050e+02 lambda=7.2725649346261757e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.434696063559e+02 lambda=7.2725649346261764e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.433964618996e+02 lambda=7.2725649346261768e-07 > > Line search: Cubically determined step, current gnorm > 1.433958141405e+02 lambda=7.2725649346261771e-08 > > 36 SNES Function norm 1.433958141405e+02 > > 0 KSP Residual norm 2.164813477994e+03 > > 1 KSP Residual norm 1.148881458292e-10 > > Line search: gnorm after quadratic fit 9.626940870744e+08 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.210459267934e+08 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.531855101756e+07 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.966826097072e+06 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.611808255272e+05 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.746062783262e+04 lambda=3.1250000000000002e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.252259871244e+03 lambda=1.5625000000000001e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.319447372021e+03 lambda=7.8125000000000004e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.963055448218e+02 lambda=3.9062500000000002e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.719034797105e+02 lambda=1.3935000445038475e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.436664111092e+02 lambda=1.3935000445038476e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.433983336239e+02 lambda=1.3935000445038476e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.433958213497e+02 lambda=1.3935000445038476e-07 > > Line search: Cubically determined step, current gnorm > 1.433958104705e+02 lambda=5.1202466521517630e-08 > > 37 SNES Function norm 1.433958104705e+02 > > 0 KSP Residual norm 5.470482746849e+03 > > 1 KSP Residual norm 2.077456833170e-10 > > Line search: gnorm after quadratic fit 1.541335606193e+10 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.922526157954e+09 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.393079394383e+08 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.967573549050e+07 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.657319925168e+06 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.479516204895e+05 lambda=3.1250000000000002e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.573399122917e+04 lambda=1.5625000000000001e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.931177424479e+03 lambda=7.8125000000000004e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.619710606187e+03 lambda=3.9062500000000002e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.924551713717e+02 lambda=1.9531250000000001e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.786095404459e+02 lambda=6.2808469554243522e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.437467476469e+02 lambda=6.2808469554243527e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.433992463439e+02 lambda=6.2808469554243527e-07 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.433958367271e+02 lambda=6.2808469554243525e-08 > > Line search: Cubically determined step, current gnorm > 1.433958098948e+02 lambda=8.0208105170108588e-09 > > 38 SNES Function norm 1.433958098948e+02 > > 0 KSP Residual norm 1.380568582849e+04 > > 1 KSP Residual norm 3.830866223513e-10 > > Line search: gnorm after quadratic fit 2.484973518314e+11 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.108953896984e+10 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.893104137528e+09 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.884003910853e+08 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.150765563542e+07 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.811161146103e+06 lambda=3.1250000000000002e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.011017986781e+06 lambda=1.5625000000000001e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.368084343451e+05 lambda=7.8125000000000004e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.042876665700e+04 lambda=3.9062500000000002e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.648735196752e+03 lambda=1.9531250000000001e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 8.489051252413e+02 lambda=9.7656250000000005e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.910677756717e+02 lambda=4.7728537787817724e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.505452645186e+02 lambda=1.1099980464343249e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.434658984864e+02 lambda=1.1099980464343249e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.433964956476e+02 lambda=1.1099980464343249e-07 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.433958153212e+02 lambda=1.1099980464343250e-08 > > Line search: Cubically determined step, current gnorm > 1.433958098048e+02 lambda=1.2587012037197021e-09 > > 39 SNES Function norm 1.433958098048e+02 > > 0 KSP Residual norm 3.492284741552e+04 > > 1 KSP Residual norm 2.459788921244e-09 > > Line search: gnorm after quadratic fit 4.017424324975e+12 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.020053801097e+11 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.270768402853e+10 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.827801904036e+09 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 9.758550488105e+08 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.213492627852e+08 lambda=3.1250000000000002e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.502191365805e+07 lambda=1.5625000000000001e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.846947104704e+06 lambda=7.8125000000000004e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.262850216093e+05 lambda=3.9062500000000002e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.879926646684e+04 lambda=1.9531250000000001e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.510203332079e+03 lambda=9.7656250000000005e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.055028679619e+03 lambda=4.8828125000000003e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.503903269554e+02 lambda=2.3633949212111800e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.510245991472e+02 lambda=4.5897967908360529e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.434724062782e+02 lambda=4.5897967908360533e-07 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.433965706606e+02 lambda=4.5897967908360533e-08 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.433958168196e+02 lambda=4.5897967908360538e-09 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.433958098155e+02 lambda=4.5897967908360540e-10 > > Line search: Cubically determined step, current gnorm > 1.433958097906e+02 lambda=1.9745369723997599e-10 > > 40 SNES Function norm 1.433958097906e+02 > > 0 KSP Residual norm 8.722495521587e+04 > > 1 KSP Residual norm 3.742695919275e-09 > > Line search: gnorm after quadratic fit 6.262538457180e+13 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.829256308992e+12 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 9.789282877890e+11 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.224340679566e+11 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.532137613500e+10 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.919506047737e+09 lambda=3.1250000000000002e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.410488718338e+08 lambda=1.5625000000000001e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.042211373104e+07 lambda=7.8125000000000004e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.881986305609e+06 lambda=3.9062500000000002e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.080857001861e+05 lambda=1.9531250000000001e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.054449734307e+04 lambda=9.7656250000000005e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.109051581397e+04 lambda=4.8828125000000003e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.144985497099e+03 lambda=2.4414062500000001e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.617627947761e+02 lambda=1.2207031250000001e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.132828960986e+02 lambda=5.3137869181552773e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.440403409760e+02 lambda=5.3137869181552777e-07 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.434022226216e+02 lambda=5.3137869181552781e-08 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.433958732177e+02 lambda=5.3137869181552781e-09 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.433958103569e+02 lambda=5.3137869181552779e-10 > > Line search: Cubically determined step, current gnorm > 1.433958097894e+02 lambda=5.3137869181552781e-11 > > 41 SNES Function norm 1.433958097894e+02 > > 0 KSP Residual norm 6.453169081212e+04 > > 1 KSP Residual norm 2.762540688686e-09 > > Line search: gnorm after quadratic fit 2.535166112592e+13 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.168366990040e+12 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.958985371462e+11 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.945064622488e+10 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.172244865713e+09 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.693002384290e+08 lambda=3.1250000000000002e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 9.562568994785e+07 lambda=1.5625000000000001e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.182957296890e+07 lambda=7.8125000000000004e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.453260254263e+06 lambda=3.9062500000000002e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.781984147743e+05 lambda=1.9531250000000001e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.294934468515e+04 lambda=9.7656250000000005e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.740461720782e+03 lambda=4.8828125000000003e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 9.162621855154e+02 lambda=2.4414062500000001e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.042417294890e+02 lambda=1.1290474210136388e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.458920680477e+02 lambda=1.4201366604660443e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.434208620254e+02 lambda=1.4201366604660444e-07 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.433960586269e+02 lambda=1.4201366604660445e-08 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.433958120934e+02 lambda=1.4201366604660445e-09 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.433958097940e+02 lambda=1.4201366604660446e-10 > > Line search: Cubically determined step, current gnorm > 1.433958097852e+02 lambda=5.7981795207229486e-11 > > 42 SNES Function norm 1.433958097852e+02 > > 0 KSP Residual norm 1.596625793747e+05 > > 1 KSP Residual norm 6.465899717071e-09 > > Line search: gnorm after quadratic fit 3.840699863976e+14 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.801237514773e+13 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.002454410823e+12 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.505340831651e+11 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 9.387378188418e+10 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.174857842415e+10 lambda=3.1250000000000002e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.472211181784e+09 lambda=1.5625000000000001e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.849608933788e+08 lambda=7.8125000000000004e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.336592011613e+07 lambda=3.9062500000000002e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.988079805895e+06 lambda=1.9531250000000001e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.930858080425e+05 lambda=9.7656250000000005e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.521190722497e+04 lambda=4.8828125000000003e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 8.872153015323e+03 lambda=2.4414062500000001e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.772337662956e+03 lambda=1.2207031250000001e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.879470852054e+02 lambda=6.1035156250000003e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.942774855488e+02 lambda=2.4957912736226801e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.438719078958e+02 lambda=2.4957912736226800e-07 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.434005516391e+02 lambda=2.4957912736226800e-08 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.433958568732e+02 lambda=2.4957912736226803e-09 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.433958102244e+02 lambda=2.4957912736226804e-10 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.433958097865e+02 lambda=2.4957912736226805e-11 > > Line search: Cubically determined step, current gnorm > 1.433958097846e+02 lambda=9.2900433293108317e-12 > > 43 SNES Function norm 1.433958097846e+02 > > 0 KSP Residual norm 4.230869747157e+05 > > 1 KSP Residual norm 2.238707423027e-08 > > Line search: gnorm after quadratic fit 7.145700515048e+15 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 8.931871281700e+14 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.116420341041e+14 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.395366610168e+13 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.743811756566e+12 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.178776103292e+11 lambda=3.1250000000000002e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.721012032848e+10 lambda=1.5625000000000001e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.395186924428e+09 lambda=7.8125000000000004e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.229125978585e+08 lambda=3.9062500000000002e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.250971135953e+07 lambda=1.9531250000000001e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.483856203094e+06 lambda=9.7656250000000005e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.950671355228e+05 lambda=4.8828125000000003e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 9.795408218555e+04 lambda=2.4414062500000001e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.315025696280e+04 lambda=1.2207031250000001e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.395961070555e+03 lambda=6.1035156250000003e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.565070307576e+02 lambda=3.0517578125000002e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.228949713871e+02 lambda=1.2154989071946628e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.441831998014e+02 lambda=1.2154989071946629e-07 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.434037055996e+02 lambda=1.2154989071946630e-08 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.433958886074e+02 lambda=1.2154989071946630e-09 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.433958105564e+02 lambda=1.2154989071946630e-10 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.433958097907e+02 lambda=1.2154989071946631e-11 > > Line search: Cubically determined step, current gnorm > 1.433958097845e+02 lambda=1.3559489351735629e-12 > > 44 SNES Function norm 1.433958097845e+02 > > 0 KSP Residual norm 1.017589039922e+06 > > 1 KSP Residual norm 5.483283808994e-08 > > Line search: gnorm after quadratic fit 9.942386816509e+16 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.242813073279e+16 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.553553149772e+15 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.942033483320e+14 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.427772097758e+13 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.035291372732e+12 lambda=3.1250000000000002e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.795558047824e+11 lambda=1.5625000000000001e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.748073147307e+10 lambda=7.8125000000000004e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.944235240368e+09 lambda=3.9062500000000002e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.453550734860e+08 lambda=1.9531250000000001e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 9.377045707707e+07 lambda=9.7656250000000005e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.188119937132e+07 lambda=4.8828125000000003e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.529730353136e+06 lambda=2.4414062500000001e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.044646611329e+05 lambda=1.2207031250000001e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.974477616118e+04 lambda=6.1035156250000003e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.087923877078e+03 lambda=3.0517578125000002e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.112257173311e+03 lambda=1.5258789062500001e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.536190077033e+02 lambda=7.6293945312500004e-07 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.622567424729e+02 lambda=2.4244966960965791e-07 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.435780438142e+02 lambda=2.4244966960965793e-08 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.433976282603e+02 lambda=2.4244966960965796e-09 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.433958279382e+02 lambda=2.4244966960965797e-10 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.433958099632e+02 lambda=2.4244966960965799e-11 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.433958097860e+02 lambda=2.4244966960965801e-12 > > Line search: Cubically determined step, current gnorm > 1.433958097845e+02 lambda=2.4244966960965801e-13 > > 45 SNES Function norm 1.433958097845e+02 > > 0 KSP Residual norm 2.206687220910e+06 > > 1 KSP Residual norm 4.897651438902e-08 > > Line search: gnorm after quadratic fit 1.013883843512e+18 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.267347883019e+17 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.584167551460e+16 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.980166189110e+15 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.475099638694e+14 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.093604443378e+13 lambda=3.1250000000000002e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.866330988164e+12 lambda=1.5625000000000001e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.831230804145e+11 lambda=7.8125000000000004e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.034848618023e+10 lambda=3.9062500000000002e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.533173457427e+09 lambda=1.9531250000000001e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 9.390937545910e+08 lambda=9.7656250000000005e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.167706366282e+08 lambda=4.8828125000000003e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.445357932595e+07 lambda=2.4414062500000001e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.776833600920e+06 lambda=1.2207031250000001e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.177171496134e+05 lambda=6.1035156250000003e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.775750596740e+04 lambda=3.0517578125000002e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.374283858049e+03 lambda=1.5258789062500001e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.030949543491e+03 lambda=7.6293945312500004e-07 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.423064811256e+02 lambda=3.6673216108643130e-07 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.499924205417e+02 lambda=6.7541706529544844e-08 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.434620968378e+02 lambda=6.7541706529544851e-09 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.433964732224e+02 lambda=6.7541706529544853e-10 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.433958164087e+02 lambda=6.7541706529544856e-11 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.433958098496e+02 lambda=6.7541706529544860e-12 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.433958097850e+02 lambda=6.7541706529544869e-13 > > Line search: unable to find good step length! After 24 tries > > Line search: fnorm=1.4339580978447020e+02, > gnorm=1.4339580978501337e+02, ynorm=2.2066872446260620e+06, > minlambda=9.9999999999999998e-13, lambda=6.7541706529544869e-13, initial > slope=-2.0562359199040133e+04 > > 0 SNES Function norm 7.494832241120e+03 > > 0 KSP Residual norm 2.096735360816e+01 > > 1 KSP Residual norm 1.310027756820e-12 > > Line search: gnorm after quadratic fit 6.728375857515e+03 > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > 1 SNES Function norm 6.728375857515e+03 > > 0 KSP Residual norm 2.051806116405e+01 > > 1 KSP Residual norm 4.624620138831e-13 > > Line search: gnorm after quadratic fit 6.028616261650e+03 > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > 2 SNES Function norm 6.028616261650e+03 > > 0 KSP Residual norm 2.416503160016e+01 > > 1 KSP Residual norm 8.456041680630e-13 > > Line search: gnorm after quadratic fit 5.407473517447e+03 > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > 3 SNES Function norm 5.407473517447e+03 > > 0 KSP Residual norm 1.429873750399e+01 > > 1 KSP Residual norm 2.956316145819e-13 > > Line search: Using full step: fnorm 5.407473517447e+03 gnorm > 1.894530516076e+03 > > 4 SNES Function norm 1.894530516076e+03 > > 0 KSP Residual norm 2.898580554597e+00 > > 1 KSP Residual norm 6.622560162623e-14 > > Line search: Using full step: fnorm 1.894530516076e+03 gnorm > 1.794029421846e+03 > > 5 SNES Function norm 1.794029421846e+03 > > 0 KSP Residual norm 1.749678611959e+01 > > 1 KSP Residual norm 8.138905825078e-12 > > Line search: gnorm after quadratic fit 1.767361408940e+03 > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > 6 SNES Function norm 1.767361408940e+03 > > 0 KSP Residual norm 1.094404109423e+02 > > 1 KSP Residual norm 7.696691527700e-12 > > Line search: gnorm after quadratic fit 3.545750923895e+04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.153479540314e+03 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.205683629874e+03 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.802976525485e+03 lambda=1.2441094586006883e-02 > > Line search: Cubically determined step, current gnorm > 1.765063299263e+03 lambda=4.9240328094708914e-03 > > 7 SNES Function norm 1.765063299263e+03 > > 0 KSP Residual norm 1.778095975189e+01 > > 1 KSP Residual norm 2.814661813934e-12 > > Line search: gnorm after quadratic fit 2.620761680117e+03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.793045753271e+03 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm > 1.740299227935e+03 lambda=2.5000000000000001e-02 > > 8 SNES Function norm 1.740299227935e+03 > > 0 KSP Residual norm 3.284236894535e+02 > > 1 KSP Residual norm 5.172103783952e-10 > > Line search: gnorm after quadratic fit 2.857820523902e+05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.063993491139e+04 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.588139591650e+03 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.491163684413e+03 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.802614760566e+03 lambda=5.7977212395253904e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.741444490992e+03 lambda=1.8448315876950813e-03 > > Line search: Cubically determined step, current gnorm > 1.739663656043e+03 lambda=7.7468345598227730e-04 > > 9 SNES Function norm 1.739663656043e+03 > > 0 KSP Residual norm 4.581839103558e+02 > > 1 KSP Residual norm 2.627035885943e-11 > > Line search: gnorm after quadratic fit 8.199478499066e+05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.127270076812e+05 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.816774161281e+04 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.053723877333e+03 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.971814513392e+03 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.755066208174e+03 lambda=2.7232010924558834e-03 > > Line search: Cubically determined step, current gnorm > 1.739559834479e+03 lambda=8.1458417855297680e-04 > > 10 SNES Function norm 1.739559834479e+03 > > 0 KSP Residual norm 1.463056810139e+02 > > 1 KSP Residual norm 5.383584598825e-12 > > Line search: gnorm after quadratic fit 2.885699620595e+04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.847717401708e+03 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.244464170034e+03 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.769157604338e+03 lambda=1.0857209099577540e-02 > > Line search: Cubically determined step, current gnorm > 1.737356225452e+03 lambda=4.0312937622950231e-03 > > 11 SNES Function norm 1.737356225452e+03 > > 0 KSP Residual norm 1.564105677925e+02 > > 1 KSP Residual norm 6.671164745832e-11 > > Line search: gnorm after quadratic fit 3.815800291873e+04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.197027796134e+03 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.373151605545e+03 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.783976520867e+03 lambda=1.2093374970461970e-02 > > Line search: Cubically determined step, current gnorm > 1.735737929915e+03 lambda=4.9529698477569920e-03 > > 12 SNES Function norm 1.735737929915e+03 > > 0 KSP Residual norm 5.030757139645e+01 > > 1 KSP Residual norm 1.157542730692e-12 > > Line search: gnorm after quadratic fit 3.004544441458e+03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.850403239750e+03 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm > 1.722893188305e+03 lambda=2.0881992439921702e-02 > > 13 SNES Function norm 1.722893188305e+03 > > 0 KSP Residual norm 7.123428853845e+01 > > 1 KSP Residual norm 8.671726774894e-12 > > Line search: gnorm after quadratic fit 4.361041499279e+03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.032697222107e+03 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.726212330814e+03 lambda=1.9909470348267504e-02 > > Line search: Cubically determined step, current gnorm > 1.714127356920e+03 lambda=9.9547351741337518e-03 > > 14 SNES Function norm 1.714127356920e+03 > > 0 KSP Residual norm 8.304557447257e+00 > > 1 KSP Residual norm 6.268295862688e-13 > > Line search: gnorm after quadratic fit 1.558163002487e+03 > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > 15 SNES Function norm 1.558163002487e+03 > > 0 KSP Residual norm 2.820803287164e+00 > > 1 KSP Residual norm 5.477413853752e-13 > > Line search: gnorm after quadratic fit 1.065673478530e+03 > > Line search: Quadratically determined step, > lambda=3.8943438938591052e-01 > > 16 SNES Function norm 1.065673478530e+03 > > 0 KSP Residual norm 2.296739120664e+00 > > 1 KSP Residual norm 6.273731899885e-14 > > Line search: gnorm after quadratic fit 8.964342150621e+02 > > Line search: Quadratically determined step, > lambda=1.8740736900935545e-01 > > 17 SNES Function norm 8.964342150621e+02 > > 0 KSP Residual norm 5.567568505830e+00 > > 1 KSP Residual norm 8.649083600764e-12 > > Line search: gnorm after quadratic fit 8.322514858992e+02 > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > 18 SNES Function norm 8.322514858992e+02 > > 0 KSP Residual norm 1.164393577210e+00 > > 1 KSP Residual norm 2.019248309015e-14 > > Line search: Using full step: fnorm 8.322514858992e+02 gnorm > 3.179750274746e+02 > > 19 SNES Function norm 3.179750274746e+02 > > 0 KSP Residual norm 5.339294310641e+00 > > 1 KSP Residual norm 2.070321587238e-13 > > Line search: gnorm after quadratic fit 3.433012316833e+02 > > Line search: Cubically determined step, current gnorm > 3.140305403821e+02 lambda=5.0000000000000003e-02 > > 20 SNES Function norm 3.140305403821e+02 > > 0 KSP Residual norm 1.177016565578e+01 > > 1 KSP Residual norm 2.413027540446e-13 > > Line search: gnorm after quadratic fit 7.377851778409e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.896721016582e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm > 3.136619309181e+02 lambda=9.7219892278716195e-03 > > 21 SNES Function norm 3.136619309181e+02 > > 0 KSP Residual norm 3.973565083977e+00 > > 1 KSP Residual norm 9.726786674410e-14 > > Line search: gnorm after quadratic fit 3.098277326090e+02 > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > 22 SNES Function norm 3.098277326090e+02 > > 0 KSP Residual norm 9.389290683519e+00 > > 1 KSP Residual norm 1.651497163724e-13 > > Line search: gnorm after quadratic fit 6.887970540455e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.588146381477e+02 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.099274823603e+02 lambda=1.6890426151283184e-02 > > Line search: Cubically determined step, current gnorm > 3.084890760827e+02 lambda=8.4452130756415920e-03 > > 23 SNES Function norm 3.084890760827e+02 > > 0 KSP Residual norm 2.381130479641e+00 > > 1 KSP Residual norm 4.694489283156e-14 > > Line search: gnorm after quadratic fit 2.872151876535e+02 > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > 24 SNES Function norm 2.872151876535e+02 > > 0 KSP Residual norm 2.405498502269e+00 > > 1 KSP Residual norm 3.316846070538e-13 > > Line search: gnorm after quadratic fit 2.686789761232e+02 > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > 25 SNES Function norm 2.686789761232e+02 > > 0 KSP Residual norm 1.728772970554e+00 > > 1 KSP Residual norm 4.132974383339e-14 > > Line search: gnorm after quadratic fit 2.365009918229e+02 > > Line search: Quadratically determined step, > lambda=1.7273357529379074e-01 > > 26 SNES Function norm 2.365009918229e+02 > > 0 KSP Residual norm 4.413764759374e+00 > > 1 KSP Residual norm 5.210690816917e-14 > > Line search: gnorm after quadratic fit 2.756730968257e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.372321757171e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm > 2.335020811250e+02 lambda=2.5000000000000001e-02 > > 27 SNES Function norm 2.335020811250e+02 > > 0 KSP Residual norm 1.606246507553e+00 > > 1 KSP Residual norm 3.564847846678e-14 > > Line search: gnorm after quadratic fit 2.078263630653e+02 > > Line search: Quadratically determined step, > lambda=1.5913860995949433e-01 > > 28 SNES Function norm 2.078263630653e+02 > > 0 KSP Residual norm 3.700632954873e+00 > > 1 KSP Residual norm 5.113863400264e-13 > > Line search: gnorm after quadratic fit 2.142503514807e+02 > > Line search: Cubically determined step, current gnorm > 2.021095009118e+02 lambda=5.0000000000000003e-02 > > 29 SNES Function norm 2.021095009118e+02 > > 0 KSP Residual norm 3.056449560135e+00 > > 1 KSP Residual norm 3.207987681334e-14 > > Line search: gnorm after quadratic fit 2.064252530802e+02 > > Line search: Cubically determined step, current gnorm > 1.978069081639e+02 lambda=5.0000000000000003e-02 > > 30 SNES Function norm 1.978069081639e+02 > > 0 KSP Residual norm 2.024695620703e+00 > > 1 KSP Residual norm 5.460360737995e-14 > > Line search: gnorm after quadratic fit 1.839556530796e+02 > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > 31 SNES Function norm 1.839556530796e+02 > > 0 KSP Residual norm 1.610676619931e+01 > > 1 KSP Residual norm 6.703552136307e-13 > > Line search: gnorm after quadratic fit 7.186735314913e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.905672430097e+02 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.856766286600e+02 lambda=1.0830798014298563e-02 > > Line search: Cubically determined step, current gnorm > 1.836818937131e+02 lambda=3.3207362501459785e-03 > > 32 SNES Function norm 1.836818937131e+02 > > 0 KSP Residual norm 7.471722173131e+01 > > 1 KSP Residual norm 2.671534648829e-12 > > Line search: gnorm after quadratic fit 9.613379909411e+04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.509491298762e+04 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.808861367705e+03 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.767283758299e+02 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.665421328348e+02 lambda=6.0369453941238101e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.869726717041e+02 lambda=1.4394327006264963e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.836897704575e+02 lambda=1.4394327006264963e-04 > > Line search: Cubically determined step, current gnorm > 1.836767951408e+02 lambda=5.5567420418543164e-05 > > 33 SNES Function norm 1.836767951408e+02 > > 0 KSP Residual norm 2.702367712138e+01 > > 1 KSP Residual norm 2.731656687850e-12 > > Line search: gnorm after quadratic fit 3.331563146098e+03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 8.723694790688e+02 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.941243220944e+02 lambda=2.1443568774664485e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.847231733910e+02 lambda=2.7571330376860012e-03 > > Line search: Cubically determined step, current gnorm > 1.836356729409e+02 lambda=4.7841280418270480e-04 > > 34 SNES Function norm 1.836356729409e+02 > > 0 KSP Residual norm 1.228333177997e+01 > > 1 KSP Residual norm 2.681127387880e-13 > > Line search: gnorm after quadratic fit 6.936329223475e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.749327218775e+02 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.871557327742e+02 lambda=1.4160505301999991e-02 > > Line search: Cubically determined step, current gnorm > 1.833523080682e+02 lambda=3.5196326548579192e-03 > > 35 SNES Function norm 1.833523080682e+02 > > 0 KSP Residual norm 3.531886257396e+02 > > 1 KSP Residual norm 2.364634092895e-11 > > Line search: gnorm after quadratic fit 3.994783047929e+06 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.753715960726e+05 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.516669898185e+04 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.918985942348e+03 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.363599250418e+03 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.344906818752e+02 lambda=3.1250000000000002e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.991088183980e+02 lambda=1.0108094710462592e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.834621681844e+02 lambda=1.0108094710462593e-04 > > Line search: Cubically determined step, current gnorm > 1.833517377324e+02 lambda=1.0108094710462594e-05 > > 36 SNES Function norm 1.833517377324e+02 > > 0 KSP Residual norm 9.005833507118e+01 > > 1 KSP Residual norm 6.116387880629e-12 > > Line search: gnorm after quadratic fit 8.899847103226e+04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.388111536526e+04 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.532652074749e+03 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.864912734009e+02 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.421068789960e+02 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.873498120960e+02 lambda=2.1924025345283278e-03 > > Line search: Cubically determined step, current gnorm > 1.833506987706e+02 lambda=2.1924025345283280e-04 > > 37 SNES Function norm 1.833506987706e+02 > > 0 KSP Residual norm 1.548426525207e+01 > > 1 KSP Residual norm 1.038038773942e-12 > > Line search: gnorm after quadratic fit 6.702848665441e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.789880616078e+02 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.846521504351e+02 lambda=1.0567302644323170e-02 > > Line search: Cubically determined step, current gnorm > 1.830548481815e+02 lambda=3.5274490352771972e-03 > > 38 SNES Function norm 1.830548481815e+02 > > 0 KSP Residual norm 1.523095478807e+01 > > 1 KSP Residual norm 1.963823596119e-12 > > Line search: gnorm after quadratic fit 9.255727478491e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.496757253461e+02 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.863126241242e+02 lambda=9.3143291632966311e-03 > > Line search: Cubically determined step, current gnorm > 1.829091761403e+02 lambda=1.8107234819462800e-03 > > 39 SNES Function norm 1.829091761403e+02 > > 0 KSP Residual norm 1.311320726934e+01 > > 1 KSP Residual norm 9.084170520902e-13 > > Line search: gnorm after quadratic fit 7.488610069188e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.691148243365e+02 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.885558228772e+02 lambda=1.9439894235886539e-02 > > Line search: Cubically determined step, current gnorm > 1.825540619134e+02 lambda=5.4967824488704169e-03 > > 40 SNES Function norm 1.825540619134e+02 > > 0 KSP Residual norm 1.218635557505e+01 > > 1 KSP Residual norm 7.760485728617e-13 > > Line search: gnorm after quadratic fit 6.636453826807e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.880828006022e+02 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.830493790584e+02 lambda=6.6234802648049863e-03 > > Line search: Cubically determined step, current gnorm > 1.823397545268e+02 lambda=2.4308217464828865e-03 > > 41 SNES Function norm 1.823397545268e+02 > > 0 KSP Residual norm 9.456543593865e+00 > > 1 KSP Residual norm 7.046593270309e-13 > > Line search: gnorm after quadratic fit 3.369769163110e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.105230957789e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm > 1.817897533119e+02 lambda=9.1612481372917148e-03 > > 42 SNES Function norm 1.817897533119e+02 > > 0 KSP Residual norm 7.290035145805e+00 > > 1 KSP Residual norm 3.198962158141e-12 > > Line search: gnorm after quadratic fit 2.858311567415e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.965004842981e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm > 1.808845577764e+02 lambda=1.3826421990147811e-02 > > 43 SNES Function norm 1.808845577764e+02 > > 0 KSP Residual norm 7.256785036157e+00 > > 1 KSP Residual norm 9.243179217625e-14 > > Line search: gnorm after quadratic fit 2.534388176390e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.916726818893e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm > 1.797953125543e+02 lambda=1.3677747819164022e-02 > > 44 SNES Function norm 1.797953125543e+02 > > 0 KSP Residual norm 1.716201096352e+01 > > 1 KSP Residual norm 2.701418800808e-13 > > Line search: gnorm after quadratic fit 1.331064301474e+03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.461842246267e+02 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.920668830294e+02 lambda=1.2856504859057132e-02 > > Line search: Cubically determined step, current gnorm > 1.797121460957e+02 lambda=1.4396611381500967e-03 > > 45 SNES Function norm 1.797121460957e+02 > > 0 KSP Residual norm 6.613432967985e+00 > > 1 KSP Residual norm 1.357752977076e-13 > > Line search: gnorm after quadratic fit 2.721288927858e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.939638282615e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm > 1.787985482018e+02 lambda=1.2647907914070569e-02 > > 46 SNES Function norm 1.787985482018e+02 > > 0 KSP Residual norm 1.225736349281e+01 > > 1 KSP Residual norm 3.819378790812e-13 > > Line search: gnorm after quadratic fit 4.548006065036e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.304803559060e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm > 1.787344729174e+02 lambda=8.9002284237256531e-03 > > 47 SNES Function norm 1.787344729174e+02 > > 0 KSP Residual norm 6.302465402340e+00 > > 1 KSP Residual norm 6.980931947122e-14 > > Line search: gnorm after quadratic fit 2.879477700004e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.980806946742e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm > 1.780128006935e+02 lambda=1.0223293444602008e-02 > > 48 SNES Function norm 1.780128006935e+02 > > 0 KSP Residual norm 4.323829277968e+00 > > 1 KSP Residual norm 5.223881369308e-13 > > Line search: gnorm after quadratic fit 1.957928151218e+02 > > Line search: Cubically determined step, current gnorm > 1.768899805640e+02 lambda=5.0000000000000003e-02 > > 49 SNES Function norm 1.768899805640e+02 > > 0 KSP Residual norm 2.249256107033e+00 > > 1 KSP Residual norm 3.624400957270e-14 > > Line search: gnorm after quadratic fit 1.704782114773e+02 > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > 50 SNES Function norm 1.704782114773e+02 > > 0 SNES Function norm 3.513783397332e+03 > > 0 KSP Residual norm 1.650214950648e+01 > > 1 KSP Residual norm 3.574269752690e-13 > > Line search: gnorm after quadratic fit 3.155830404050e+03 > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > 1 SNES Function norm 3.155830404050e+03 > > 0 KSP Residual norm 1.443734018042e+01 > > 1 KSP Residual norm 3.685565191058e-13 > > Line search: Using full step: fnorm 3.155830404050e+03 gnorm > 8.581212204155e+02 > > 2 SNES Function norm 8.581212204155e+02 > > 0 KSP Residual norm 2.492601775565e+00 > > 1 KSP Residual norm 9.698440210389e-14 > > Line search: Using full step: fnorm 8.581212204155e+02 gnorm > 7.018609898542e+02 > > 3 SNES Function norm 7.018609898542e+02 > > 0 KSP Residual norm 1.740320986421e+00 > > 1 KSP Residual norm 2.868780682435e-14 > > Line search: Using full step: fnorm 7.018609898542e+02 gnorm > 2.135824235887e+02 > > 4 SNES Function norm 2.135824235887e+02 > > 0 KSP Residual norm 1.647413497077e+00 > > 1 KSP Residual norm 2.731226225666e-14 > > Line search: gnorm after quadratic fit 1.936469032649e+02 > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > 5 SNES Function norm 1.936469032649e+02 > > 0 KSP Residual norm 1.406615972124e+00 > > 1 KSP Residual norm 3.167179626699e-14 > > Line search: gnorm after quadratic fit 1.755362571467e+02 > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > 6 SNES Function norm 1.755362571467e+02 > > 0 KSP Residual norm 1.480681706594e+00 > > 1 KSP Residual norm 2.935210968935e-14 > > Line search: gnorm after quadratic fit 1.597659506616e+02 > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > 7 SNES Function norm 1.597659506616e+02 > > 0 KSP Residual norm 4.013154698097e+00 > > 1 KSP Residual norm 1.021628704832e-13 > > Line search: gnorm after quadratic fit 1.728408060966e+02 > > Line search: Cubically determined step, current gnorm > 1.570815760721e+02 lambda=5.0000000000000003e-02 > > 8 SNES Function norm 1.570815760721e+02 > > 0 KSP Residual norm 1.510335662636e+00 > > 1 KSP Residual norm 2.728243244724e-14 > > Line search: gnorm after quadratic fit 1.450162880692e+02 > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > 9 SNES Function norm 1.450162880692e+02 > > 0 KSP Residual norm 1.923349271077e+01 > > 1 KSP Residual norm 1.640711956406e-11 > > Line search: gnorm after quadratic fit 1.016537223115e+03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.584263092048e+02 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.490729346583e+02 lambda=9.3725990358703350e-03 > > Line search: Cubically determined step, current gnorm > 1.449349273006e+02 lambda=1.5464889706033082e-03 > > 10 SNES Function norm 1.449349273006e+02 > > 0 KSP Residual norm 1.154999084194e+01 > > 1 KSP Residual norm 1.292167633338e-11 > > Line search: gnorm after quadratic fit 6.060386918705e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.236630526035e+02 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.491201927819e+02 lambda=1.6816056300124185e-02 > > Line search: Cubically determined step, current gnorm > 1.447023047013e+02 lambda=4.1484374564153808e-03 > > 11 SNES Function norm 1.447023047013e+02 > > 0 KSP Residual norm 7.278906180502e+00 > > 1 KSP Residual norm 2.815632651924e-12 > > Line search: gnorm after quadratic fit 2.512278711773e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.624350957814e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm > 1.441656049510e+02 lambda=1.0879389002513012e-02 > > 12 SNES Function norm 1.441656049510e+02 > > 0 KSP Residual norm 4.449836480267e+00 > > 1 KSP Residual norm 3.152365624813e-13 > > Line search: gnorm after quadratic fit 1.749680739878e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.458763435996e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm > 1.425715025152e+02 lambda=2.2766809271842225e-02 > > 13 SNES Function norm 1.425715025152e+02 > > 0 KSP Residual norm 4.218495037726e+00 > > 1 KSP Residual norm 1.398472536142e-12 > > Line search: gnorm after quadratic fit 1.645159536467e+02 > > Line search: Cubically determined step, current gnorm > 1.421991559212e+02 lambda=4.1883769431247941e-02 > > 14 SNES Function norm 1.421991559212e+02 > > 0 KSP Residual norm 1.968853538608e+00 > > 1 KSP Residual norm 7.594023450519e-12 > > Line search: gnorm after quadratic fit 1.350960142124e+02 > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > 15 SNES Function norm 1.350960142124e+02 > > 0 KSP Residual norm 3.444721686085e+00 > > 1 KSP Residual norm 5.312609674019e-14 > > Line search: gnorm after quadratic fit 1.472880565107e+02 > > Line search: Cubically determined step, current gnorm > 1.336714620145e+02 lambda=4.1341550820829437e-02 > > 16 SNES Function norm 1.336714620145e+02 > > 0 KSP Residual norm 3.276288899397e+00 > > 1 KSP Residual norm 8.394674946715e-14 > > Line search: gnorm after quadratic fit 1.459274497150e+02 > > Line search: Cubically determined step, current gnorm > 1.327618539486e+02 lambda=5.0000000000000003e-02 > > 17 SNES Function norm 1.327618539486e+02 > > 0 KSP Residual norm 2.630052244303e+00 > > 1 KSP Residual norm 4.351283410507e-14 > > Line search: gnorm after quadratic fit 1.350378060116e+02 > > Line search: Cubically determined step, current gnorm > 1.299403903934e+02 lambda=4.9913529436269283e-02 > > 18 SNES Function norm 1.299403903934e+02 > > 0 KSP Residual norm 6.124953430138e+00 > > 1 KSP Residual norm 2.295381352938e-13 > > Line search: gnorm after quadratic fit 2.275621676963e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.469611730657e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm > 1.294890694898e+02 lambda=1.0071939100661648e-02 > > 19 SNES Function norm 1.294890694898e+02 > > 0 KSP Residual norm 1.036733907011e+01 > > 1 KSP Residual norm 1.800941381283e-13 > > Line search: gnorm after quadratic fit 3.844879463595e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.875071148504e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm > 1.294494430642e+02 lambda=5.0000000000000010e-03 > > 20 SNES Function norm 1.294494430642e+02 > > 0 KSP Residual norm 8.224001595443e+00 > > 1 KSP Residual norm 3.337810156182e-13 > > Line search: gnorm after quadratic fit 3.332325263497e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.682441841234e+02 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.294720538860e+02 lambda=8.5401597581228530e-03 > > Line search: Cubically determined step, current gnorm > 1.291762382985e+02 lambda=4.2555418164960989e-03 > > 21 SNES Function norm 1.291762382985e+02 > > 0 KSP Residual norm 3.920749219860e+01 > > 1 KSP Residual norm 1.610902886435e-12 > > Line search: gnorm after quadratic fit 3.472422440640e+03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.023065712859e+03 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.228184088700e+02 lambda=1.6004598823093592e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.298607525058e+02 lambda=1.6004598823093593e-03 > > Line search: Cubically determined step, current gnorm > 1.291643460998e+02 lambda=1.9319076533745672e-04 > > 22 SNES Function norm 1.291643460998e+02 > > 0 KSP Residual norm 1.520092314848e+02 > > 1 KSP Residual norm 7.089159192434e-11 > > Line search: gnorm after quadratic fit 2.752539686422e+05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.237188995536e+04 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.484370498858e+03 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.571039994484e+03 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.280898858362e+02 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.708927009106e+02 lambda=2.6114913411793973e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.294919567784e+02 lambda=2.6114913411793975e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.291645609810e+02 lambda=2.6114913411793977e-05 > > Line search: Cubically determined step, current gnorm > 1.291635530596e+02 lambda=1.2278773895355162e-05 > > 23 SNES Function norm 1.291635530596e+02 > > 0 KSP Residual norm 7.569206058965e+02 > > 1 KSP Residual norm 3.454693729751e-11 > > Line search: gnorm after quadratic fit 2.570888738395e+07 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.064965025187e+06 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.498514098182e+05 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.807487005202e+04 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.233167830543e+03 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.396736912757e+03 lambda=3.1250000000000002e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.547572543330e+02 lambda=1.2623406091699435e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.335889024473e+02 lambda=1.8542137907683829e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.292059042479e+02 lambda=1.8542137907683831e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.291637618568e+02 lambda=1.8542137907683832e-06 > > Line search: Cubically determined step, current gnorm > 1.291635210734e+02 lambda=4.9524172913414387e-07 > > 24 SNES Function norm 1.291635210734e+02 > > 0 KSP Residual norm 3.761913422861e+03 > > 1 KSP Residual norm 6.181718776929e-10 > > Line search: gnorm after quadratic fit 3.342370445037e+09 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.218326646111e+08 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.375128803204e+07 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.980626157021e+06 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 9.407418671219e+05 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.357321025399e+05 lambda=3.1250000000000002e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.188948059047e+04 lambda=1.5625000000000001e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.105117929713e+03 lambda=7.8125000000000004e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 9.331054736818e+02 lambda=3.9062500000000002e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.942479792843e+02 lambda=1.9412500272460620e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.436944624694e+02 lambda=6.4483223307578726e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.292972287211e+02 lambda=6.4483223307578726e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.291647778160e+02 lambda=6.4483223307578730e-07 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.291635261433e+02 lambda=6.4483223307578730e-08 > > Line search: Cubically determined step, current gnorm > 1.291635197798e+02 lambda=2.0042115918485846e-08 > > 25 SNES Function norm 1.291635197798e+02 > > 0 KSP Residual norm 1.874745766083e+04 > > 1 KSP Residual norm 1.476978150334e-09 > > Line search: gnorm after quadratic fit 4.089262111368e+11 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.101717203770e+10 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.352565940292e+09 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.879613196620e+08 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 9.698613558125e+07 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.175566265039e+07 lambda=3.1250000000000002e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.382919964952e+06 lambda=1.5625000000000001e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.545431975334e+05 lambda=7.8125000000000004e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.713561369103e+04 lambda=3.9062500000000002e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.031789308419e+03 lambda=1.9531250000000001e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 9.205847020738e+02 lambda=9.7656250000000005e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.957203153158e+02 lambda=2.8132879163728503e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.297923302791e+02 lambda=2.8132879163728504e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.291698100579e+02 lambda=2.8132879163728504e-07 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.291635794525e+02 lambda=2.8132879163728506e-08 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.291635200489e+02 lambda=2.8132879163728508e-09 > > Line search: Cubically determined step, current gnorm > 1.291635197275e+02 lambda=8.0832061492461345e-10 > > 26 SNES Function norm 1.291635197275e+02 > > 0 KSP Residual norm 9.248381077528e+04 > > 1 KSP Residual norm 7.262307068447e-09 > > Line search: gnorm after quadratic fit 4.920647210624e+13 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.153216818065e+12 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.697543960375e+11 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 9.637004379805e+10 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.208402653149e+10 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.519988135798e+09 lambda=3.1250000000000002e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.923903214787e+08 lambda=1.5625000000000001e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.465663001976e+07 lambda=7.8125000000000004e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.238603967195e+06 lambda=3.9062500000000002e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.459179143177e+05 lambda=1.9531250000000001e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.676301042792e+04 lambda=9.7656250000000005e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.135808875752e+04 lambda=4.8828125000000003e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.275714918657e+03 lambda=2.4414062500000001e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.719037747616e+02 lambda=1.2207031250000001e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.039826156716e+02 lambda=5.5609199181402721e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.308092967809e+02 lambda=9.1057337296683134e-07 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.291796742824e+02 lambda=9.1057337296683134e-08 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.291636800174e+02 lambda=9.1057337296683134e-09 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.291635212255e+02 lambda=9.1057337296683134e-10 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.291635197320e+02 lambda=9.1057337296683139e-11 > > Line search: Cubically determined step, current gnorm > 1.291635197254e+02 lambda=3.2898162617097329e-11 > > 27 SNES Function norm 1.291635197254e+02 > > 0 KSP Residual norm 4.818745996826e+05 > > 1 KSP Residual norm 3.300979345194e-08 > > Line search: gnorm after quadratic fit 6.957046028867e+15 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 8.695654311477e+14 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.086793500688e+14 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.358083744813e+13 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.696584801696e+12 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.118183549773e+11 lambda=3.1250000000000002e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.641372080976e+10 lambda=1.5625000000000001e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.285878535769e+09 lambda=7.8125000000000004e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.068045470276e+08 lambda=3.9062500000000002e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.988290932539e+07 lambda=1.9531250000000001e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.001404304764e+06 lambda=9.7656250000000005e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.962234585736e+05 lambda=4.8828125000000003e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.648190078115e+04 lambda=2.4414062500000001e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 9.098288624714e+03 lambda=1.2207031250000001e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.025132922751e+03 lambda=6.1035156250000003e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.536770142392e+02 lambda=3.0517578125000002e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.529553964021e+02 lambda=6.6615844706846272e-07 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.293970371303e+02 lambda=6.6615844706846277e-08 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.291658631829e+02 lambda=6.6615844706846284e-09 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.291635430890e+02 lambda=6.6615844706846284e-10 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.291635199508e+02 lambda=6.6615844706846284e-11 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.291635197268e+02 lambda=6.6615844706846284e-12 > > Line search: Cubically determined step, current gnorm > 1.291635197253e+02 lambda=1.2496728806533799e-12 > > 28 SNES Function norm 1.291635197253e+02 > > 0 KSP Residual norm 2.124622394867e+06 > > 1 KSP Residual norm 2.766225333896e-07 > > Line search: gnorm after quadratic fit 5.963587884154e+17 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.454611858824e+16 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 9.318582340500e+15 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.164902175749e+15 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.456326197371e+14 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.820904039469e+13 lambda=3.1250000000000002e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.277371273495e+12 lambda=1.5625000000000001e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.849819609184e+11 lambda=7.8125000000000004e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.570050545145e+10 lambda=3.9062500000000002e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.482064028328e+09 lambda=1.9531250000000001e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.651631635063e+08 lambda=9.7656250000000005e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.188623828904e+07 lambda=4.8828125000000003e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 9.302868645305e+06 lambda=2.4414062500000001e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.245214424313e+06 lambda=1.2207031250000001e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.775004618570e+05 lambda=6.1035156250000003e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.810228834086e+04 lambda=3.0517578125000002e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.148910945566e+03 lambda=1.5258789062500001e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.133679879416e+03 lambda=7.6293945312500004e-07 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.382468615011e+02 lambda=3.8146972656250002e-07 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.519773483633e+02 lambda=1.4103864371136453e-07 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.293690599792e+02 lambda=1.4103864371136454e-08 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.291655645282e+02 lambda=1.4103864371136455e-09 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.291635401518e+02 lambda=1.4103864371136456e-10 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.291635199283e+02 lambda=1.4103864371136456e-11 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.291635197272e+02 lambda=1.4103864371136456e-12 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.291635197253e+02 lambda=1.4103864371136457e-13 > > Line search: unable to find good step length! After 25 tries > > Line search: fnorm=1.2916351972528861e+02, > gnorm=1.2916351972529532e+02, ynorm=2.1246218291095798e+06, > minlambda=9.9999999999999998e-13, lambda=1.4103864371136457e-13, initial > slope=-1.6683210999382733e+04 > > 0 SNES Function norm 7.158176401507e+03 > > 0 KSP Residual norm 7.545626598553e+02 > > 1 KSP Residual norm 2.192822940623e-11 > > Line search: gnorm after quadratic fit 6.003975664723e+07 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.501930637484e+06 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 9.380142516806e+05 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.179837352860e+05 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.656902039419e+04 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.340091686120e+03 lambda=3.1250000000000002e-03 > > Line search: Cubically determined step, current gnorm > 7.127478647243e+03 lambda=1.5625000000000001e-03 > > 1 SNES Function norm 7.127478647243e+03 > > 0 KSP Residual norm 3.139792512249e+01 > > 1 KSP Residual norm 5.765552480238e-13 > > Line search: gnorm after quadratic fit 7.131728282938e+03 > > Line search: Cubically determined step, current gnorm > 6.730387269330e+03 lambda=5.0000000000000003e-02 > > 2 SNES Function norm 6.730387269330e+03 > > 0 KSP Residual norm 2.247436817553e+01 > > 1 KSP Residual norm 4.129717651221e-13 > > Line search: gnorm after quadratic fit 6.018304311910e+03 > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > 3 SNES Function norm 6.018304311910e+03 > > 0 KSP Residual norm 1.605973421081e+01 > > 1 KSP Residual norm 3.614891198134e-13 > > Line search: gnorm after quadratic fit 5.394599276028e+03 > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > 4 SNES Function norm 5.394599276028e+03 > > 0 KSP Residual norm 1.491002227850e+01 > > 1 KSP Residual norm 5.905756964447e-13 > > Line search: gnorm after quadratic fit 4.845108544722e+03 > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > 5 SNES Function norm 4.845108544722e+03 > > 0 KSP Residual norm 1.562997766581e+02 > > 1 KSP Residual norm 5.722461855805e-12 > > Line search: gnorm after quadratic fit 1.663505509947e+05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.368547472010e+04 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.067825049920e+03 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.852173464442e+03 lambda=1.2500000000000001e-02 > > Line search: Cubically determined step, current gnorm > 4.819549937425e+03 lambda=6.2500000000000003e-03 > > 6 SNES Function norm 4.819549937425e+03 > > 0 KSP Residual norm 1.652787385042e+01 > > 1 KSP Residual norm 7.774483442550e-13 > > Line search: gnorm after quadratic fit 2.868840270198e+03 > > Line search: Quadratically determined step, > lambda=3.9586658383856743e-01 > > 7 SNES Function norm 2.868840270198e+03 > > 0 KSP Residual norm 1.220061851091e+01 > > 1 KSP Residual norm 4.785407437718e-13 > > Line search: gnorm after quadratic fit 2.616720732407e+03 > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > 8 SNES Function norm 2.616720732407e+03 > > 0 KSP Residual norm 2.884722153958e+01 > > 1 KSP Residual norm 5.474553921306e-13 > > Line search: gnorm after quadratic fit 3.025386805317e+03 > > Line search: Cubically determined step, current gnorm > 2.572110173067e+03 lambda=5.0000000000000003e-02 > > 9 SNES Function norm 2.572110173067e+03 > > 0 KSP Residual norm 5.239447686736e+01 > > 1 KSP Residual norm 1.006906008399e-12 > > Line search: gnorm after quadratic fit 5.237562098046e+03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.722529781980e+03 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm > 2.553072891461e+03 lambda=2.5000000000000001e-02 > > 10 SNES Function norm 2.553072891461e+03 > > 0 KSP Residual norm 6.511316788880e+00 > > 1 KSP Residual norm 1.340296659008e-13 > > Line search: gnorm after quadratic fit 2.299704119080e+03 > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > 11 SNES Function norm 2.299704119080e+03 > > 0 KSP Residual norm 5.268131426587e+00 > > 1 KSP Residual norm 1.017563310127e-13 > > Line search: Using full step: fnorm 2.299704119080e+03 gnorm > 7.642690039388e+02 > > 12 SNES Function norm 7.642690039388e+02 > > 0 KSP Residual norm 1.467735721574e+01 > > 1 KSP Residual norm 1.090242963543e-12 > > Line search: gnorm after quadratic fit 1.042766084830e+03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.924803860137e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm > 7.581126971182e+02 lambda=1.8508848315139208e-02 > > 13 SNES Function norm 7.581126971182e+02 > > 0 KSP Residual norm 2.222609581896e+00 > > 1 KSP Residual norm 5.661437314341e-14 > > Line search: gnorm after quadratic fit 6.235337602260e+02 > > Line search: Quadratically determined step, > lambda=2.1172883827013136e-01 > > 14 SNES Function norm 6.235337602260e+02 > > 0 KSP Residual norm 3.080209609798e+00 > > 1 KSP Residual norm 6.073476899313e-14 > > Line search: gnorm after quadratic fit 5.704745248520e+02 > > Line search: Quadratically determined step, > lambda=1.0142301129466913e-01 > > 15 SNES Function norm 5.704745248520e+02 > > 0 KSP Residual norm 5.628316803979e+00 > > 1 KSP Residual norm 9.930477041779e-14 > > Line search: gnorm after quadratic fit 5.401354794776e+02 > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > 16 SNES Function norm 5.401354794776e+02 > > 0 KSP Residual norm 2.052541406719e+01 > > 1 KSP Residual norm 4.328836834239e-13 > > Line search: gnorm after quadratic fit 1.709850100987e+03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.717966555703e+02 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.414032576976e+02 lambda=8.7805694170804971e-03 > > Line search: Cubically determined step, current gnorm > 5.391967144330e+02 lambda=3.6341472475199424e-03 > > 17 SNES Function norm 5.391967144330e+02 > > 0 KSP Residual norm 2.246993769488e+00 > > 1 KSP Residual norm 5.078373642913e-14 > > Line search: gnorm after quadratic fit 4.939618639951e+02 > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > 18 SNES Function norm 4.939618639951e+02 > > 0 KSP Residual norm 2.155867648564e+00 > > 1 KSP Residual norm 4.438622106380e-14 > > Line search: gnorm after quadratic fit 4.334377322188e+02 > > Line search: Quadratically determined step, > lambda=1.5092486954829210e-01 > > 19 SNES Function norm 4.334377322188e+02 > > 0 KSP Residual norm 8.318284791610e+00 > > 1 KSP Residual norm 6.910116607023e-13 > > Line search: gnorm after quadratic fit 6.148799641401e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.502386288041e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm > 4.297879862602e+02 lambda=1.9565738732695813e-02 > > 20 SNES Function norm 4.297879862602e+02 > > 0 KSP Residual norm 7.593855254976e+01 > > 1 KSP Residual norm 1.300639045149e-12 > > Line search: gnorm after quadratic fit 7.318016560287e+04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.832525429452e+03 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.543595712952e+03 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.752901058720e+02 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.309726315570e+02 lambda=1.2500000000000002e-03 > > Line search: Cubically determined step, current gnorm > 4.297464967378e+02 lambda=2.0986409143217158e-04 > > 21 SNES Function norm 4.297464967378e+02 > > 0 KSP Residual norm 8.492609701850e+00 > > 1 KSP Residual norm 2.830329105288e-13 > > Line search: gnorm after quadratic fit 6.575200413213e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.532760802544e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm > 4.268212296998e+02 lambda=1.8460064973695799e-02 > > 22 SNES Function norm 4.268212296998e+02 > > 0 KSP Residual norm 2.527155905469e+00 > > 1 KSP Residual norm 2.235724978394e-13 > > Line search: gnorm after quadratic fit 3.958132075117e+02 > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > 23 SNES Function norm 3.958132075117e+02 > > 0 KSP Residual norm 3.425644398425e+00 > > 1 KSP Residual norm 7.166017790799e-14 > > Line search: gnorm after quadratic fit 3.803199338641e+02 > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > 24 SNES Function norm 3.803199338641e+02 > > 0 KSP Residual norm 3.581435186688e+00 > > 1 KSP Residual norm 1.730091027109e-13 > > Line search: gnorm after quadratic fit 3.678433353709e+02 > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > 25 SNES Function norm 3.678433353709e+02 > > 0 KSP Residual norm 2.817439291614e+00 > > 1 KSP Residual norm 8.592333136485e-13 > > Line search: gnorm after quadratic fit 3.472671313564e+02 > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > 26 SNES Function norm 3.472671313564e+02 > > 0 KSP Residual norm 1.830066839089e+00 > > 1 KSP Residual norm 3.248934231575e-14 > > Line search: gnorm after quadratic fit 3.195079998571e+02 > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > 27 SNES Function norm 3.195079998571e+02 > > 0 KSP Residual norm 3.775823654589e+00 > > 1 KSP Residual norm 1.316233059492e-13 > > Line search: gnorm after quadratic fit 3.252874639934e+02 > > Line search: Cubically determined step, current gnorm > 3.125168318399e+02 lambda=5.0000000000000003e-02 > > 28 SNES Function norm 3.125168318399e+02 > > 0 KSP Residual norm 3.892613775622e+00 > > 1 KSP Residual norm 7.093200713216e-11 > > Line search: gnorm after quadratic fit 3.137590389484e+02 > > Line search: Cubically determined step, current gnorm > 3.045559021319e+02 lambda=5.0000000000000003e-02 > > 29 SNES Function norm 3.045559021319e+02 > > 0 KSP Residual norm 2.364531179390e+00 > > 1 KSP Residual norm 1.615423543115e-12 > > Line search: gnorm after quadratic fit 2.864449141431e+02 > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > 30 SNES Function norm 2.864449141431e+02 > > 0 KSP Residual norm 5.187063704081e+00 > > 1 KSP Residual norm 4.254799504045e-13 > > Line search: gnorm after quadratic fit 3.171238299438e+02 > > Line search: Cubically determined step, current gnorm > 2.859321807369e+02 lambda=4.9550691080557742e-02 > > 31 SNES Function norm 2.859321807369e+02 > > 0 KSP Residual norm 2.400449127985e+01 > > 1 KSP Residual norm 5.221032480453e-13 > > Line search: gnorm after quadratic fit 1.812538817802e+03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.647888939229e+02 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.905120335847e+02 lambda=7.3371687404129469e-03 > > Line search: Cubically determined step, current gnorm > 2.857698450683e+02 lambda=1.3231746793531958e-03 > > 32 SNES Function norm 2.857698450683e+02 > > 0 KSP Residual norm 7.438521293559e+00 > > 1 KSP Residual norm 1.293652874831e-12 > > Line search: gnorm after quadratic fit 3.600694148787e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.932936811991e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm > 2.832774969882e+02 lambda=1.8636088141277370e-02 > > 33 SNES Function norm 2.832774969882e+02 > > 0 KSP Residual norm 2.676138557891e+00 > > 1 KSP Residual norm 5.204105674042e-12 > > Line search: gnorm after quadratic fit 2.698470565576e+02 > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > 34 SNES Function norm 2.698470565576e+02 > > 0 KSP Residual norm 1.009562156863e+01 > > 1 KSP Residual norm 3.544140587695e-13 > > Line search: gnorm after quadratic fit 5.672695948559e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.197216154647e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm > 2.694068135292e+02 lambda=1.0762403784106927e-02 > > 35 SNES Function norm 2.694068135292e+02 > > 0 KSP Residual norm 3.927549314525e+00 > > 1 KSP Residual norm 2.619134786598e-13 > > Line search: gnorm after quadratic fit 2.646675787349e+02 > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > 36 SNES Function norm 2.646675787349e+02 > > 0 KSP Residual norm 3.630219417922e+01 > > 1 KSP Residual norm 1.546302717349e-12 > > Line search: gnorm after quadratic fit 1.827432666108e+04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.342968941151e+03 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 8.008633273369e+02 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.490753494196e+02 lambda=1.2345129233072847e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.682474011960e+02 lambda=3.3291959087019770e-03 > > Line search: Cubically determined step, current gnorm > 2.646227701989e+02 lambda=4.0529212866107715e-04 > > 37 SNES Function norm 2.646227701989e+02 > > 0 KSP Residual norm 8.122774697994e+00 > > 1 KSP Residual norm 1.316362046092e-13 > > Line search: gnorm after quadratic fit 4.731092571363e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.030088374328e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm > 2.637462652877e+02 lambda=9.1057248517509397e-03 > > 38 SNES Function norm 2.637462652877e+02 > > 0 KSP Residual norm 2.601520363063e+00 > > 1 KSP Residual norm 1.060764270007e-12 > > Line search: gnorm after quadratic fit 2.536856446094e+02 > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > 39 SNES Function norm 2.536856446094e+02 > > 0 KSP Residual norm 5.447955134327e+01 > > 1 KSP Residual norm 2.556989975730e-12 > > Line search: gnorm after quadratic fit 9.199250935618e+03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.998238940105e+03 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.227083769291e+02 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.852215674478e+02 lambda=8.5024965111563117e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.537821339347e+02 lambda=8.5024965111563122e-04 > > Line search: Cubically determined step, current gnorm > 2.536484146652e+02 lambda=2.9594242443314720e-04 > > 40 SNES Function norm 2.536484146652e+02 > > 0 KSP Residual norm 3.357359266965e+01 > > 1 KSP Residual norm 8.485166742752e-11 > > Line search: gnorm after quadratic fit 3.327150899857e+03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 8.660943990394e+02 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.428891921377e+02 lambda=2.2262238648584176e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.550059920785e+02 lambda=3.9120439672600755e-03 > > Line search: Cubically determined step, current gnorm > 2.535425543202e+02 lambda=8.8078244093807846e-04 > > 41 SNES Function norm 2.535425543202e+02 > > 0 KSP Residual norm 1.982789391732e+01 > > 1 KSP Residual norm 1.156473750758e-11 > > Line search: gnorm after quadratic fit 9.648483369708e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.023504841042e+02 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.554919970151e+02 lambda=8.7092873850291869e-03 > > Line search: Cubically determined step, current gnorm > 2.532490636747e+02 lambda=2.4564558988847251e-03 > > 42 SNES Function norm 2.532490636747e+02 > > 0 KSP Residual norm 1.762994613361e+01 > > 1 KSP Residual norm 4.550684860593e-12 > > Line search: gnorm after quadratic fit 6.772107527838e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.370541870778e+02 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.532869639177e+02 lambda=7.7662700854918328e-03 > > Line search: Cubically determined step, current gnorm > 2.527651129995e+02 lambda=3.8686733161537824e-03 > > 43 SNES Function norm 2.527651129995e+02 > > 0 KSP Residual norm 1.559278923951e+01 > > 1 KSP Residual norm 1.060470887103e-11 > > Line search: gnorm after quadratic fit 7.344361373020e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.498001534426e+02 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.530518382567e+02 lambda=7.6730113050967469e-03 > > Line search: Cubically determined step, current gnorm > 2.523423548732e+02 lambda=3.4156098513217236e-03 > > 44 SNES Function norm 2.523423548732e+02 > > 0 KSP Residual norm 1.190500639095e+01 > > 1 KSP Residual norm 6.311739265577e-12 > > Line search: gnorm after quadratic fit 4.875196633557e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.933215922947e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm > 2.516782376717e+02 lambda=9.8878729665301743e-03 > > 45 SNES Function norm 2.516782376717e+02 > > 0 KSP Residual norm 1.003632001309e+01 > > 1 KSP Residual norm 7.039473047666e-13 > > Line search: gnorm after quadratic fit 3.417133560813e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.636443273929e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm > 2.499729768042e+02 lambda=1.5332495922160540e-02 > > 46 SNES Function norm 2.499729768042e+02 > > 0 KSP Residual norm 5.252587112411e+01 > > 1 KSP Residual norm 2.072629114336e-12 > > Line search: gnorm after quadratic fit 7.891803681498e+03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.819076698717e+03 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.911876424956e+02 lambda=2.4538865368827514e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.688195882303e+02 lambda=6.5764457912135515e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.500076295129e+02 lambda=6.5764457912135523e-04 > > Line search: Cubically determined step, current gnorm > 2.499390700783e+02 lambda=2.7231956365922875e-04 > > 47 SNES Function norm 2.499390700783e+02 > > 0 KSP Residual norm 4.007648116930e+01 > > 1 KSP Residual norm 5.646654234336e-11 > > Line search: gnorm after quadratic fit 6.276152857499e+03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.418274035925e+03 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.785345842563e+02 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.665412152699e+02 lambda=8.0607289886479045e-03 > > Line search: Cubically determined step, current gnorm > 2.499109739904e+02 lambda=8.0607289886479045e-04 > > 48 SNES Function norm 2.499109739904e+02 > > 0 KSP Residual norm 1.339756751889e+01 > > 1 KSP Residual norm 2.559175980945e-13 > > Line search: gnorm after quadratic fit 6.052259901869e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.217431518450e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm > 2.496541765916e+02 lambda=7.0239599632283649e-03 > > 49 SNES Function norm 2.496541765916e+02 > > 0 KSP Residual norm 5.340771873687e+00 > > 1 KSP Residual norm 1.207454778077e-13 > > Line search: gnorm after quadratic fit 2.760767095070e+02 > > Line search: Cubically determined step, current gnorm > 2.491630276458e+02 lambda=5.0000000000000003e-02 > > 50 SNES Function norm 2.491630276458e+02 > > > > > > On Sat, Aug 26, 2017 at 11:45 PM, Barry Smith > wrote: > > > > > On Aug 26, 2017, at 10:43 PM, zakaryah . wrote: > > > > > > Hi Barry - many thanks for taking the time to understand my many > problems and providing so much help. > > > > > > The reason I was concerned that I could not alter the linesearch was > when I tried to use bt instead of the L-BFGS default, cp, the code crashed > with an error like "Could not get Jacobian". Maybe this is an > incompatibility like you say, since L-BFGS only uses the initial Jacobian > and I never tried setting the scale type. > > > > > > I took your advice and tried to shrink the problem. First I tried > shrinking by a factor 1000 but this converged very quickly with all test > data I could provide, including the data which was problematic with the > large grid. So I settled for a reduction in size by a factor 125. The > grid size is 13,230. This is a decent test case because the solver fails > to converge with the options I was using before, and it is small enough > that I can run it with the options you suggested (-snes_fd_color -snes_type > newtonls -snes_monitor -snes_linesearch_monitor -ksp_monitor -pc_type lu). > > > > > > The output is 1800 lines long - how shall I share it? > > > > Just email it, that is small enough for email. > > > > Barry > > > > > > > > > > > > > > > > > On Sat, Aug 26, 2017 at 7:38 PM, Barry Smith > wrote: > > > > > > > On Aug 26, 2017, at 5:56 PM, zakaryah . wrote: > > > > > > > > I'm using PETSc's SNES methods to solve PDEs which result from > Euler-Lagrange equations for the strain energy of a 3D displacement field. > There is an additional term in the Lagrangian which describes external > forces which arise from various data sets, and that term contains > nonlinearities (field terms higher than linear). The grid has about 1.6e6 > elements, and the displacement field has 3 components at each grid element. > > > > > > > > I'm trying to solve a sequence of successively more complicated > equations, and the latest equation is failing to converge on some data > sets. In particular, the methods were successful for the infinitesimal bulk > strain (compression) energy, as well as the full infinitesimal strain > energy (bulk + shear), but I'm now trying to generalize to the finite > strain, as certain data sets are known to result from displacement fields > for which the infinitesimal strain is a poor approximation. > > > > > > > > I'm using a DMDA, closely following example 48, and my preferred > solver is L-BFGS. > > > > > > So you are using ? > > > > > > -snes_type qn -snes_qn_type lbfgs > > > > > > > > > > > I have read the FAQs "Why is Newton's method not converging??" and > "Why is my iterative linear solver not converging??"? which have raised a > number of questions: > > > > > > Quasi Newton methods either don't use Jacobians or use only the > initial Jacobian (the idea behind quasi-Newton methods is to approximate > Jacobian information from previous iterations without having the user > compute a Jacobian at each iteration). With PETSc's qn it only uses the > Jacobian if you use the option > > > > > > -snes_qn_scale_type Jacobian > > > > > > otherwise the Jacobian is never computed or used > > > > > > > > > > > > > > Is there documentation for the DMDA/SNES methods somewhere? I don't > understand these very well. For example, I am not allocating any matrix > for the global Jacobian, and I believe this prevents me from changing the > line search. If I'm mistaken I would love to see an example of changing > the line search type while using DMDA/SNES. > > > > > > Whether you provide a Jacobian or not is orthogonal to the line > search. > > > > > > You should be able to change the line search with > > > > > > -snes_linesearch_type bt or nleqerr or basic or l2 or cp > > > > > > not all of them may work with qn > > > > > > > > > > > > > > I don't know how to interpret the linesearch monitor. Even for > problems which are converging properly, the linesearch monitor reports > "lssucceed=0" on every iteration. Is this a problem? > > > > > > It returns a 0 if the line search does not believe it has achieved > "sufficient decrease" in the function norm (or possibly some other measure > of decrease) you should run -snes_linesearch_monitor also with the option > -snes_monitor to see what is happening to the function norm > > > > > > For qn you can add the option > > > > > > -snes_qn_monitor > > > > > > to get more detailed monitoring > > > > > > > > > > > > > > I'm also having trouble understanding the methods for > troubleshooting. I suspect that I've made an error in the analytical > Jacobian, which has a rather large number of non-zero elements, but I have > no idea how to use -snes_type test -snes_test_display. The FAQs mention > that some troubleshooting tools are more useful for small test problems. > How small is small? > > > > > > Tiny, at most a few dozen rows and columns in the Jacobin. > > > > > > You should run without the -snes_test_display information, what > does it say? Does it indicate the Jacobian or report there is likely a > problem? > > > > > > With DMDA you can also use -snes_fd_color to have PETSc compute > the Jacobian for you instead of using your analytical form. If it works > with this, but not your Jacobian then your Jacobian is wrong. > > > > > > > When I try to run the program with -snes_type test > -snes_test_display, I get errors like: > > > > > > > > [0]PETSC ERROR: Argument out of range [0]PETSC ERROR: Local index > 1076396032 too large 4979879 (max) at 0 > > > > > > > > The second size is 1 less than the number of field elements, while > the first number seems too large for any aspect of the problem - the > Jacobian has at most 59 non-zero columns per row. > > > > > > > > Because I suspect a possible error in the Jacobian, I ran with > -snes_mf_operator -pc_type ksp -ksp_ksp_rtol 1e-12 and observed very > similar failure to converge (diverging residual) as with the explicit > Jacobian. > > > > > > What do you get with -ksp_monitor -ksp_ksp_monitor it sounds like > the true Jacobian is either very ill-conditioned or your function > evaluation is wrong. > > > > > > > Do I need to set an SNES method which is somehow compatible with the > "matrix-free" approach? If I instead use -snes_mf, the problem seems to > converge, but horrendously slowly (true residual relative decrease by about > 1e-5 per iteration). I suppose this supports my suspicion that the > Jacobian is incorrect but doesn't really suggest a solution. > > > > > > > > Is it possible that the analytical Jacobian is correct, but somehow > pathological, which causes the SNES to diverge? > > > > > > Yes > > > > > > > Neither the Jacobian nor the function have singularities. > > > > > > > > Thanks for any help you can provide! > > > > > > Try really hard to set up a small problem (like just use a very > coarse grid) to experiment with as you try to get convergence. Using a big > problem for debugging convergence is a recipe for pain. > > > > > > Also since you have a Jacobian I would start with -snes_fd_color > -snes_type ls -snes_monitor -snes_linesearch_monitor -ksp_monitor -pc_type > lu (not on a huge problem), what happens? Send the output > > > > > > Barry > > > > > > > > > > > > > > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Sat Aug 26 23:11:57 2017 From: bsmith at mcs.anl.gov (Barry Smith) Date: Sat, 26 Aug 2017 23:11:57 -0500 Subject: [petsc-users] A number of questions about DMDA with SNES and Quasi-Newton methods In-Reply-To: References: <020DAED9-AAAD-4741-976B-BB2EF6C79D3F@mcs.anl.gov> <5BF530F6-8D79-47E6-B2C5-B0702FF2AA59@mcs.anl.gov> <7EE84495-4346-4BFB-B9AD-BCAA3C722461@mcs.anl.gov> Message-ID: > On Aug 26, 2017, at 10:55 PM, zakaryah . wrote: > > Yes, except I changed "-snes_type ls" to "-snes_type newtonls" because PETSc complained that ls wasn't a known method. Sorry, my memory is not as good as it used to be; but what other options did you use? Send the exact command line. Barry ' > > On Sat, Aug 26, 2017 at 11:52 PM, Barry Smith wrote: > > My exact options did you run with? > > > On Aug 26, 2017, at 10:48 PM, zakaryah . wrote: > > > > Here's the output, from the data set which does not converge with l-bfgs: > > > > 0 SNES Function norm 1.370293318432e+04 > > 0 KSP Residual norm 7.457506389218e+02 > > 1 KSP Residual norm 2.244764079994e-10 > > Line search: gnorm after quadratic fit 6.541298279196e+05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.963717927372e+04 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.788909416707e+04 lambda=2.5000000000000001e-02 > > Line search: Cubically determined step, current gnorm 1.340565762719e+04 lambda=1.2500000000000001e-02 > > 1 SNES Function norm 1.340565762719e+04 > > 0 KSP Residual norm 4.096066553372e+02 > > 1 KSP Residual norm 3.313671167444e-11 > > Line search: gnorm after quadratic fit 1.113749573695e+06 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.406390140546e+05 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.126781917443e+04 lambda=2.5000000000000001e-02 > > Line search: Cubically determined step, current gnorm 1.272988597973e+04 lambda=1.2500000000000001e-02 > > 2 SNES Function norm 1.272988597973e+04 > > 0 KSP Residual norm 8.291344597817e+01 > > 1 KSP Residual norm 7.182258362182e-12 > > Line search: gnorm after quadratic fit 1.121913743889e+04 > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > 3 SNES Function norm 1.121913743889e+04 > > 0 KSP Residual norm 6.830535877014e+01 > > 1 KSP Residual norm 3.629826411580e-12 > > Line search: gnorm after quadratic fit 9.966344973786e+03 > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > 4 SNES Function norm 9.966344973786e+03 > > 0 KSP Residual norm 5.137691531345e+01 > > 1 KSP Residual norm 1.954502098181e-12 > > Line search: gnorm after quadratic fit 8.905508641232e+03 > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > 5 SNES Function norm 8.905508641232e+03 > > 0 KSP Residual norm 4.295019262963e+01 > > 1 KSP Residual norm 1.581527994925e-12 > > Line search: gnorm after quadratic fit 7.599173694189e+03 > > Line search: Quadratically determined step, lambda=1.4157226463489950e-01 > > 6 SNES Function norm 7.599173694189e+03 > > 0 KSP Residual norm 3.520472291520e+01 > > 1 KSP Residual norm 1.169994130568e-12 > > Line search: gnorm after quadratic fit 6.797214843928e+03 > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > 7 SNES Function norm 6.797214843928e+03 > > 0 KSP Residual norm 2.683523206056e+01 > > 1 KSP Residual norm 9.039858014119e-13 > > Line search: gnorm after quadratic fit 6.098038917364e+03 > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > 8 SNES Function norm 6.098038917364e+03 > > 0 KSP Residual norm 2.300710560681e+01 > > 1 KSP Residual norm 1.010402303464e-12 > > Line search: gnorm after quadratic fit 5.486151385552e+03 > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > 9 SNES Function norm 5.486151385552e+03 > > 0 KSP Residual norm 2.824628827619e+01 > > 1 KSP Residual norm 1.009589866569e-12 > > Line search: gnorm after quadratic fit 4.964991021247e+03 > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > 10 SNES Function norm 4.964991021247e+03 > > 0 KSP Residual norm 6.285926028595e+01 > > 1 KSP Residual norm 2.833546214180e-12 > > Line search: gnorm after quadratic fit 2.100041391472e+04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.804051080767e+03 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm 4.893296169579e+03 lambda=2.5000000000000001e-02 > > 11 SNES Function norm 4.893296169579e+03 > > 0 KSP Residual norm 1.688978282804e+01 > > 1 KSP Residual norm 5.927677470786e-13 > > Line search: gnorm after quadratic fit 4.400894622431e+03 > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > 12 SNES Function norm 4.400894622431e+03 > > 0 KSP Residual norm 1.481197699600e+01 > > 1 KSP Residual norm 4.522572128105e-13 > > Line search: Using full step: fnorm 4.400894622431e+03 gnorm 2.094971849007e+03 > > 13 SNES Function norm 2.094971849007e+03 > > 0 KSP Residual norm 3.514164563318e+00 > > 1 KSP Residual norm 3.022385947499e-13 > > Line search: gnorm after quadratic fit 1.687641025382e+03 > > Line search: Quadratically determined step, lambda=2.0307116693368590e-01 > > 14 SNES Function norm 1.687641025382e+03 > > 0 KSP Residual norm 2.138591884686e+00 > > 1 KSP Residual norm 4.023500814078e-14 > > Line search: Using full step: fnorm 1.687641025382e+03 gnorm 1.131934218470e+03 > > 15 SNES Function norm 1.131934218470e+03 > > 0 KSP Residual norm 3.245035110327e+00 > > 1 KSP Residual norm 1.293626215269e-13 > > Line search: Using full step: fnorm 1.131934218470e+03 gnorm 7.340573607307e+02 > > 16 SNES Function norm 7.340573607307e+02 > > 0 KSP Residual norm 1.957698957904e+00 > > 1 KSP Residual norm 3.444648967078e-13 > > Line search: Using full step: fnorm 7.340573607307e+02 gnorm 5.024723505168e+02 > > 17 SNES Function norm 5.024723505168e+02 > > 0 KSP Residual norm 2.510538703839e+00 > > 1 KSP Residual norm 8.570440675253e-14 > > Line search: gnorm after quadratic fit 4.548776456608e+02 > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > 18 SNES Function norm 4.548776456608e+02 > > 0 KSP Residual norm 6.741705718178e-01 > > 1 KSP Residual norm 1.650556120809e-14 > > Line search: Using full step: fnorm 4.548776456608e+02 gnorm 1.351189086642e+02 > > 19 SNES Function norm 1.351189086642e+02 > > 0 KSP Residual norm 7.653741241950e+00 > > 1 KSP Residual norm 8.326848236950e-14 > > Line search: gnorm after quadratic fit 4.215455105006e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.889750369356e+02 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.358691836999e+02 lambda=1.0303015930243279e-02 > > Line search: Cubically determined step, current gnorm 1.348911963390e+02 lambda=3.5279526770504110e-03 > > 20 SNES Function norm 1.348911963390e+02 > > 0 KSP Residual norm 4.209281176918e+00 > > 1 KSP Residual norm 1.233232881375e-13 > > Line search: gnorm after quadratic fit 1.860023264470e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.413911132196e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm 1.339597869053e+02 lambda=1.5787957598629023e-02 > > 21 SNES Function norm 1.339597869053e+02 > > 0 KSP Residual norm 1.718484765841e+00 > > 1 KSP Residual norm 6.666016296543e-14 > > Line search: gnorm after quadratic fit 1.326878521472e+02 > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > 22 SNES Function norm 1.326878521472e+02 > > 0 KSP Residual norm 1.515373499919e+00 > > 1 KSP Residual norm 2.259154130795e-12 > > Line search: gnorm after quadratic fit 1.226907316391e+02 > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > 23 SNES Function norm 1.226907316391e+02 > > 0 KSP Residual norm 1.080252936903e+00 > > 1 KSP Residual norm 1.847020526683e-14 > > Line search: gnorm after quadratic fit 1.163632111851e+02 > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > 24 SNES Function norm 1.163632111851e+02 > > 0 KSP Residual norm 2.491746958382e+00 > > 1 KSP Residual norm 6.389134193637e-14 > > Line search: gnorm after quadratic fit 1.345487153563e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.169738363622e+02 lambda=4.4108900954515480e-02 > > Line search: Cubically determined step, current gnorm 1.152177638108e+02 lambda=1.9997442889243631e-02 > > 25 SNES Function norm 1.152177638108e+02 > > 0 KSP Residual norm 5.364385501004e+00 > > 1 KSP Residual norm 8.457149562463e-14 > > Line search: gnorm after quadratic fit 2.722095758964e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.480946353374e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm 1.150680255994e+02 lambda=6.3560128131639167e-03 > > 26 SNES Function norm 1.150680255994e+02 > > 0 KSP Residual norm 4.302025268263e+00 > > 1 KSP Residual norm 1.017526937941e-13 > > Line search: gnorm after quadratic fit 1.956300983573e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.318600522939e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm 1.147123505014e+02 lambda=7.6060788653548803e-03 > > 27 SNES Function norm 1.147123505014e+02 > > 0 KSP Residual norm 6.195463111324e+00 > > 1 KSP Residual norm 1.235283250361e-13 > > Line search: gnorm after quadratic fit 3.324821547049e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.612593208504e+02 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.147389525772e+02 lambda=6.1750939181374294e-03 > > Line search: Cubically determined step, current gnorm 1.145411432123e+02 lambda=3.0078592586792975e-03 > > 28 SNES Function norm 1.145411432123e+02 > > 0 KSP Residual norm 1.454704250187e+01 > > 1 KSP Residual norm 2.368485174123e-13 > > Line search: gnorm after quadratic fit 1.216293873116e+03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.796524621727e+02 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.359314163651e+02 lambda=1.4867675803955788e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.146009802557e+02 lambda=1.4867675803955788e-03 > > Line search: Cubically determined step, current gnorm 1.145096815033e+02 lambda=5.5250912472932839e-04 > > 29 SNES Function norm 1.145096815033e+02 > > 0 KSP Residual norm 3.430451345093e+01 > > 1 KSP Residual norm 1.069396165938e-12 > > Line search: gnorm after quadratic fit 1.161329407098e+04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.260690718050e+03 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.696806489042e+02 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.960149915648e+02 lambda=1.1276129246469476e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.158113641658e+02 lambda=1.5873910451430554e-03 > > Line search: Cubically determined step, current gnorm 1.145062232916e+02 lambda=1.5873910451430555e-04 > > 30 SNES Function norm 1.145062232916e+02 > > 0 KSP Residual norm 2.662578971526e+01 > > 1 KSP Residual norm 5.464011789728e-13 > > Line search: gnorm after quadratic fit 4.375119254490e+03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.038018103928e+03 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.169328002874e+02 lambda=2.3789161387159519e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.262835432714e+02 lambda=5.9737415571960795e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.145626045197e+02 lambda=5.9737415571960802e-04 > > Line search: Cubically determined step, current gnorm 1.144968604079e+02 lambda=1.6421773527706333e-04 > > 31 SNES Function norm 1.144968604079e+02 > > 0 KSP Residual norm 6.322033697338e+01 > > 1 KSP Residual norm 1.507157991448e-12 > > Line search: gnorm after quadratic fit 5.809243699277e+04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.460487584142e+03 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.893183483197e+03 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.960337007072e+02 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.771527792790e+02 lambda=5.3912931685137378e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.150137639707e+02 lambda=5.3912931685137376e-04 > > Line search: Cubically determined step, current gnorm 1.144964484571e+02 lambda=5.3912931685137380e-05 > > 32 SNES Function norm 1.144964484571e+02 > > 0 KSP Residual norm 3.859510930996e+01 > > 1 KSP Residual norm 8.069118044382e-13 > > Line search: gnorm after quadratic fit 1.106329930525e+04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.155884463041e+03 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.933963819094e+02 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.849629797377e+02 lambda=9.7744286136270241e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.150857687050e+02 lambda=9.7744286136270254e-04 > > Line search: Cubically determined step, current gnorm 1.144922906340e+02 lambda=9.7744286136270254e-05 > > 33 SNES Function norm 1.144922906340e+02 > > 0 KSP Residual norm 4.952038022394e+01 > > 1 KSP Residual norm 7.460263245424e-13 > > Line search: gnorm after quadratic fit 3.005091127220e+04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.229308416025e+03 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.138600794682e+03 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.390856262238e+02 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.394997214983e+02 lambda=4.4582997750629580e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.146836358799e+02 lambda=4.4582997750629581e-04 > > Line search: Cubically determined step, current gnorm 1.144895966587e+02 lambda=4.7644082443915877e-05 > > 34 SNES Function norm 1.144895966587e+02 > > 0 KSP Residual norm 1.146914786457e+02 > > 1 KSP Residual norm 4.791627042400e-12 > > Line search: gnorm after quadratic fit 2.601294145944e+05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.324148513778e+04 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.247478406023e+03 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.200340900661e+03 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.696223112300e+02 lambda=6.1514413845115794e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.342365431983e+02 lambda=1.7502929694284564e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.146686063035e+02 lambda=1.7502929694284566e-04 > > Line search: Cubically determined step, current gnorm 1.144895868489e+02 lambda=1.7502929694284566e-05 > > 35 SNES Function norm 1.144895868489e+02 > > 0 KSP Residual norm 6.311017209658e+01 > > 1 KSP Residual norm 8.384445939117e-13 > > Line search: gnorm after quadratic fit 5.781533400572e+04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.419557746031e+03 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.886081770030e+03 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.945810143740e+02 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.767820854837e+02 lambda=5.3859001959289735e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.150034040559e+02 lambda=5.3859001959289732e-04 > > Line search: Cubically determined step, current gnorm 1.144891501665e+02 lambda=5.3859001959289732e-05 > > 36 SNES Function norm 1.144891501665e+02 > > 0 KSP Residual norm 3.880748384332e+01 > > 1 KSP Residual norm 6.400339290453e-13 > > Line search: gnorm after quadratic fit 1.122504184426e+04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.180728237366e+03 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.987870621566e+02 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.863711604331e+02 lambda=9.8150771384688824e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.150916783781e+02 lambda=9.8150771384688824e-04 > > Line search: Cubically determined step, current gnorm 1.144850837411e+02 lambda=9.8150771384688832e-05 > > 37 SNES Function norm 1.144850837411e+02 > > 0 KSP Residual norm 4.811537498557e+01 > > 1 KSP Residual norm 9.738167670242e-13 > > Line search: gnorm after quadratic fit 2.784098355218e+04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.885118868254e+03 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.074843354348e+03 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.255202820836e+02 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.365202996130e+02 lambda=4.3204204582016374e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.146504919412e+02 lambda=4.3204204582016374e-04 > > Line search: Cubically determined step, current gnorm 1.144822306241e+02 lambda=5.0376546850227848e-05 > > 38 SNES Function norm 1.144822306241e+02 > > 0 KSP Residual norm 1.120914002482e+02 > > 1 KSP Residual norm 5.452125292284e-12 > > Line search: gnorm after quadratic fit 2.427186680567e+05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.112196656857e+04 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.967397366072e+03 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.149551659770e+03 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.529630886791e+02 lambda=6.0885216927030559e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.315267519231e+02 lambda=1.6656233536183130e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.146353659250e+02 lambda=1.6656233536183130e-04 > > Line search: Cubically determined step, current gnorm 1.144820487391e+02 lambda=1.6656233536183130e-05 > > 39 SNES Function norm 1.144820487391e+02 > > 0 KSP Residual norm 7.182416170980e+01 > > 1 KSP Residual norm 1.292147133333e-12 > > Line search: gnorm after quadratic fit 8.255331293322e+04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.302939895170e+04 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.501228089911e+03 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.185010378583e+02 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.088179821424e+02 lambda=5.7489510178867142e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.168272901121e+02 lambda=9.7452649444612811e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144951972300e+02 lambda=9.7452649444612822e-05 > > Line search: Cubically determined step, current gnorm 1.144807676687e+02 lambda=2.2399506502463798e-05 > > 40 SNES Function norm 1.144807676687e+02 > > 0 KSP Residual norm 1.728679810285e+02 > > 1 KSP Residual norm 3.878068639716e-12 > > Line search: gnorm after quadratic fit 9.011020578535e+05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.111818830011e+05 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.504789858103e+04 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.754312133162e+03 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.212492111975e+02 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.199969180537e+02 lambda=2.6424184504193135e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.154794639440e+02 lambda=2.6424184504193136e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144880673342e+02 lambda=2.6424184504193136e-05 > > Line search: Cubically determined step, current gnorm 1.144805461570e+02 lambda=3.8712107591125690e-06 > > 41 SNES Function norm 1.144805461570e+02 > > 0 KSP Residual norm 4.162780846202e+02 > > 1 KSP Residual norm 1.732341544934e-11 > > Line search: gnorm after quadratic fit 1.355673864369e+07 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.747523002884e+06 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.342205048417e+05 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.425635699680e+04 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.882150659178e+03 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.259664786336e+03 lambda=3.1250000000000002e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.653670676209e+02 lambda=1.5625000000000001e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.453655830144e+02 lambda=5.8237455565260388e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.147659525018e+02 lambda=5.8237455565260393e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144827915995e+02 lambda=5.8237455565260400e-06 > > Line search: Cubically determined step, current gnorm 1.144805080017e+02 lambda=6.6689295146509104e-07 > > 42 SNES Function norm 1.144805080017e+02 > > 0 KSP Residual norm 1.004135512581e+03 > > 1 KSP Residual norm 3.867626041000e-09 > > Line search: gnorm after quadratic fit 1.832578994882e+08 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.269698278878e+07 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.792476589915e+06 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.420660371083e+05 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.321686926168e+04 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.548358078234e+03 lambda=3.1250000000000002e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.429504802276e+03 lambda=1.5625000000000001e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.317723385004e+02 lambda=7.8125000000000004e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.460079723095e+02 lambda=2.5078917343692407e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.147908977725e+02 lambda=2.5078917343692408e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144833604238e+02 lambda=2.5078917343692412e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144805106824e+02 lambda=2.5078917343692411e-07 > > Line search: Cubically determined step, current gnorm 1.144805014337e+02 lambda=1.1468707119027746e-07 > > 43 SNES Function norm 1.144805014337e+02 > > 0 KSP Residual norm 2.418614573592e+03 > > 1 KSP Residual norm 6.085078742847e-10 > > Line search: gnorm after quadratic fit 2.598476259775e+09 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.262759415873e+08 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.116845970403e+07 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.250465130250e+06 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.863493884574e+05 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.501468163771e+04 lambda=3.1250000000000002e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.482658980483e+04 lambda=1.5625000000000001e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.802395557883e+03 lambda=7.8125000000000004e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.788149582374e+02 lambda=3.9062500000000002e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.248828337038e+02 lambda=1.8333058767960295e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.186285836222e+02 lambda=3.7550993478654105e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.145209710139e+02 lambda=3.7550993478654107e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144808670668e+02 lambda=3.7550993478654111e-07 > > Line search: Cubically determined step, current gnorm 1.144805012252e+02 lambda=3.7550993478654114e-08 > > 44 SNES Function norm 1.144805012252e+02 > > 0 KSP Residual norm 1.432476672735e+03 > > 1 KSP Residual norm 7.850524783892e-11 > > Line search: gnorm after quadratic fit 5.336191593632e+08 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.625576866625e+07 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.181408387845e+06 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.003310644422e+06 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.236384273292e+05 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.658430638069e+04 lambda=3.1250000000000002e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.977463068161e+03 lambda=1.5625000000000001e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.674238499253e+02 lambda=7.8125000000000004e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.333616820791e+02 lambda=3.3764776729281175e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.161349153752e+02 lambda=4.0497161764116874e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144966925969e+02 lambda=4.0497161764116874e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144806214839e+02 lambda=4.0497161764116878e-07 > > Line search: Cubically determined step, current gnorm 1.144804979966e+02 lambda=5.6339112427782378e-08 > > 45 SNES Function norm 1.144804979966e+02 > > 0 KSP Residual norm 3.453401579761e+03 > > 1 KSP Residual norm 4.197968028126e-09 > > Line search: gnorm after quadratic fit 7.554006183767e+09 > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.471974940372e+08 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.191613865049e+08 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.509784334249e+07 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.943752478560e+06 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.597601716755e+05 lambda=3.1250000000000002e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.775572331075e+04 lambda=1.5625000000000001e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.418045407608e+03 lambda=7.8125000000000004e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.357066758731e+03 lambda=3.9062500000000002e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.859267839080e+02 lambda=1.9531250000000001e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.501494912160e+02 lambda=7.5160826909319168e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.148144926477e+02 lambda=7.5160826909319171e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144837498478e+02 lambda=7.5160826909319179e-07 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144805227746e+02 lambda=7.5160826909319182e-08 > > Line search: Cubically determined step, current gnorm 1.144804974438e+02 lambda=9.6864021663644795e-09 > > 46 SNES Function norm 1.144804974438e+02 > > 0 KSP Residual norm 8.345139428850e+03 > > 1 KSP Residual norm 1.027819754739e-09 > > Line search: gnorm after quadratic fit 1.061319903906e+11 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.325012985379e+10 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.652236226640e+09 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.055533971630e+08 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.546607716763e+07 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.134442858835e+06 lambda=3.1250000000000002e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.839168570687e+05 lambda=1.5625000000000001e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.830568178626e+04 lambda=7.8125000000000004e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.201776786081e+03 lambda=3.9062500000000002e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.540520468013e+03 lambda=1.9531250000000001e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.573504890506e+02 lambda=9.7656250000000005e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.516203908013e+02 lambda=3.2703670177372021e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.148480075676e+02 lambda=3.2703670177372022e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144841475328e+02 lambda=3.2703670177372023e-07 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144805305720e+02 lambda=3.2703670177372021e-08 > > Line search: Cubically determined step, current gnorm 1.144804974367e+02 lambda=3.2703670177372025e-09 > > 47 SNES Function norm 1.144804974367e+02 > > 0 KSP Residual norm 4.668983500382e+03 > > 1 KSP Residual norm 1.398997665317e-09 > > Line search: gnorm after quadratic fit 1.865309565532e+10 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.336975299727e+09 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.934905088739e+08 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.704520478641e+07 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.728477809448e+06 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.193001670096e+05 lambda=3.1250000000000002e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.610673238239e+04 lambda=1.5625000000000001e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.354711683605e+04 lambda=7.8125000000000004e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.589557246433e+03 lambda=3.9062500000000002e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.367851970709e+02 lambda=1.9531250000000001e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.136930269795e+02 lambda=9.0316845802227864e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.172186635069e+02 lambda=1.5831613287181393e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.145074017254e+02 lambda=1.5831613287181394e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144807499816e+02 lambda=1.5831613287181396e-07 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144804983345e+02 lambda=1.5831613287181397e-08 > > Line search: Cubically determined step, current gnorm 1.144804971346e+02 lambda=5.2932921109871310e-09 > > 48 SNES Function norm 1.144804971346e+02 > > 0 KSP Residual norm 1.132678078317e+04 > > 1 KSP Residual norm 2.477518733314e-10 > > Line search: gnorm after quadratic fit 2.654659022365e+11 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.315296223725e+10 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.136635677074e+09 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.152507060235e+08 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.397060094478e+07 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.898362012287e+06 lambda=3.1250000000000002e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.685179520906e+05 lambda=1.5625000000000001e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.194040779842e+05 lambda=7.8125000000000004e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.606415730227e+04 lambda=3.9062500000000002e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.902698091972e+03 lambda=1.9531250000000001e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.521549384652e+02 lambda=9.7656250000000005e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.288999778994e+02 lambda=4.1899746703195281e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.157880829786e+02 lambda=4.5470218451893824e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144935741206e+02 lambda=4.5470218451893828e-07 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144806232638e+02 lambda=4.5470218451893831e-08 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144804979250e+02 lambda=4.5470218451893835e-09 > > Line search: Cubically determined step, current gnorm 1.144804970825e+02 lambda=9.0293679903918216e-10 > > 49 SNES Function norm 1.144804970825e+02 > > 0 KSP Residual norm 2.712544829144e+04 > > 1 KSP Residual norm 4.949246309677e-09 > > Line search: gnorm after quadratic fit 3.650846005745e+12 > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.565321055911e+11 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.711080201118e+10 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.150022242308e+09 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.965954117985e+08 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.128096393645e+08 lambda=3.1250000000000002e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.429702091584e+07 lambda=1.5625000000000001e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.841819946536e+06 lambda=7.8125000000000004e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.465032956946e+05 lambda=3.9062500000000002e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.594210253794e+04 lambda=1.9531250000000001e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.141110278944e+03 lambda=9.7656250000000005e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.306952279045e+03 lambda=4.8828125000000003e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.754164864338e+02 lambda=2.4414062500000001e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.476861367158e+02 lambda=9.2451761406722810e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.147929263780e+02 lambda=9.2451761406722810e-07 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144836022952e+02 lambda=9.2451761406722821e-08 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144805271860e+02 lambda=9.2451761406722831e-09 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144804972895e+02 lambda=9.2451761406722839e-10 > > Line search: Cubically determined step, current gnorm 1.144804970737e+02 lambda=1.5633616333063305e-10 > > 50 SNES Function norm 1.144804970737e+02 > > 0 SNES Function norm 2.308693894796e+03 > > 0 KSP Residual norm 8.981999720532e+00 > > 1 KSP Residual norm 2.363170936183e-13 > > Line search: Using full step: fnorm 2.308693894796e+03 gnorm 7.571661187318e+02 > > 1 SNES Function norm 7.571661187318e+02 > > 0 KSP Residual norm 2.149614048903e+00 > > 1 KSP Residual norm 9.511247057888e-13 > > Line search: Using full step: fnorm 7.571661187318e+02 gnorm 4.450081004997e+02 > > 2 SNES Function norm 4.450081004997e+02 > > 0 KSP Residual norm 1.706469075123e+01 > > 1 KSP Residual norm 5.803815175472e-13 > > Line search: gnorm after quadratic fit 1.510518198899e+03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.850796532980e+02 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.515983139755e+02 lambda=2.0602556887689423e-02 > > Line search: Cubically determined step, current gnorm 4.434800867235e+02 lambda=8.2396279492937211e-03 > > 3 SNES Function norm 4.434800867235e+02 > > 0 KSP Residual norm 3.208587171626e+00 > > 1 KSP Residual norm 1.099072610659e-13 > > Line search: gnorm after quadratic fit 4.080637194736e+02 > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > 4 SNES Function norm 4.080637194736e+02 > > 0 KSP Residual norm 8.136557176540e+00 > > 1 KSP Residual norm 8.800137844173e-13 > > Line search: gnorm after quadratic fit 5.261656549654e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.131114070934e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm 4.031614746044e+02 lambda=2.4674842039461482e-02 > > 5 SNES Function norm 4.031614746044e+02 > > 0 KSP Residual norm 7.609918907567e+00 > > 1 KSP Residual norm 1.613159932655e-13 > > Line search: gnorm after quadratic fit 5.353908064984e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.110480554132e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm 3.991168240716e+02 lambda=2.3079500036735322e-02 > > 6 SNES Function norm 3.991168240716e+02 > > 0 KSP Residual norm 3.800845472041e+00 > > 1 KSP Residual norm 4.841682188278e-13 > > Line search: gnorm after quadratic fit 3.787886582952e+02 > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > 7 SNES Function norm 3.787886582952e+02 > > 0 KSP Residual norm 1.892621919219e+00 > > 1 KSP Residual norm 3.576655371800e-12 > > Line search: gnorm after quadratic fit 3.440181918909e+02 > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > 8 SNES Function norm 3.440181918909e+02 > > 0 KSP Residual norm 3.559759789147e+00 > > 1 KSP Residual norm 8.347521826622e-13 > > Line search: gnorm after quadratic fit 3.287993515195e+02 > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > 9 SNES Function norm 3.287993515195e+02 > > 0 KSP Residual norm 1.825073540507e+00 > > 1 KSP Residual norm 8.352745008123e-14 > > Line search: Using full step: fnorm 3.287993515195e+02 gnorm 2.710650507416e+02 > > 10 SNES Function norm 2.710650507416e+02 > > 0 KSP Residual norm 7.568432945608e-01 > > 1 KSP Residual norm 2.780715252274e-14 > > Line search: Using full step: fnorm 2.710650507416e+02 gnorm 1.513359047342e+02 > > 11 SNES Function norm 1.513359047342e+02 > > 0 KSP Residual norm 9.387460484575e+00 > > 1 KSP Residual norm 7.091233040676e-13 > > Line search: gnorm after quadratic fit 3.998857979851e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.060972049714e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm 1.512140169420e+02 lambda=5.4338709720680610e-03 > > 12 SNES Function norm 1.512140169420e+02 > > 0 KSP Residual norm 4.399424360499e+00 > > 1 KSP Residual norm 1.614362118182e-13 > > Line search: gnorm after quadratic fit 1.913552832643e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.559719302467e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm 1.499985374733e+02 lambda=1.7102027220313589e-02 > > 13 SNES Function norm 1.499985374733e+02 > > 0 KSP Residual norm 3.740397849742e+00 > > 1 KSP Residual norm 8.986775577006e-13 > > Line search: gnorm after quadratic fit 1.764118876632e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.522381536119e+02 lambda=4.8196830215713270e-02 > > Line search: Cubically determined step, current gnorm 1.486175880390e+02 lambda=1.8881300948189364e-02 > > 14 SNES Function norm 1.486175880390e+02 > > 0 KSP Residual norm 6.067973818528e+00 > > 1 KSP Residual norm 4.527845229549e-13 > > Line search: gnorm after quadratic fit 2.514021299115e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.679972156573e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm 1.481015724304e+02 lambda=9.0116621678703428e-03 > > 15 SNES Function norm 1.481015724304e+02 > > 0 KSP Residual norm 6.108754994263e+00 > > 1 KSP Residual norm 2.557635976440e-13 > > Line search: gnorm after quadratic fit 2.458081150104e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.681837029397e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm 1.476148340442e+02 lambda=7.9580911933571953e-03 > > 16 SNES Function norm 1.476148340442e+02 > > 0 KSP Residual norm 7.914946163932e+00 > > 1 KSP Residual norm 1.512066885699e-13 > > Line search: gnorm after quadratic fit 3.458938604598e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.883018868359e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm 1.474286108114e+02 lambda=6.7262521208543979e-03 > > 17 SNES Function norm 1.474286108114e+02 > > 0 KSP Residual norm 5.285449532689e+00 > > 1 KSP Residual norm 6.693733977456e-12 > > Line search: gnorm after quadratic fit 2.170263102661e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.607560548008e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm 1.467785507822e+02 lambda=9.9244383205188240e-03 > > 18 SNES Function norm 1.467785507822e+02 > > 0 KSP Residual norm 8.124903695635e+00 > > 1 KSP Residual norm 2.322439601127e-11 > > Line search: gnorm after quadratic fit 3.589716592364e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.907315184877e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm 1.466341888638e+02 lambda=6.5538271222582893e-03 > > 19 SNES Function norm 1.466341888638e+02 > > 0 KSP Residual norm 5.253550718343e+00 > > 1 KSP Residual norm 1.575657996883e-12 > > Line search: gnorm after quadratic fit 2.155795776725e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.598564001687e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm 1.459869404602e+02 lambda=9.9195822632931301e-03 > > 20 SNES Function norm 1.459869404602e+02 > > 0 KSP Residual norm 8.405987790193e+00 > > 1 KSP Residual norm 2.046159481178e-13 > > Line search: gnorm after quadratic fit 3.767908298426e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.941885062002e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm 1.458995232755e+02 lambda=6.4359684554015136e-03 > > 21 SNES Function norm 1.458995232755e+02 > > 0 KSP Residual norm 5.036348246593e+00 > > 1 KSP Residual norm 3.645081669075e-13 > > Line search: gnorm after quadratic fit 2.083222977519e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.575737508694e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm 1.452039802458e+02 lambda=1.0554092389542354e-02 > > 22 SNES Function norm 1.452039802458e+02 > > 0 KSP Residual norm 8.562292355998e+00 > > 1 KSP Residual norm 3.256332645483e-13 > > Line search: gnorm after quadratic fit 3.869470823355e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.959483128249e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm 1.451523830598e+02 lambda=6.3780526507799607e-03 > > 23 SNES Function norm 1.451523830598e+02 > > 0 KSP Residual norm 4.919667503862e+00 > > 1 KSP Residual norm 4.823931177115e-13 > > Line search: gnorm after quadratic fit 2.042891039525e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.560623102934e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm 1.444331916523e+02 lambda=1.0890355421223689e-02 > > 24 SNES Function norm 1.444331916523e+02 > > 0 KSP Residual norm 8.727282395369e+00 > > 1 KSP Residual norm 7.090683582186e-13 > > Line search: gnorm after quadratic fit 3.977929422821e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.978556223200e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm 1.444215965394e+02 lambda=6.3477766966048947e-03 > > 25 SNES Function norm 1.444215965394e+02 > > 0 KSP Residual norm 4.759732971179e+00 > > 1 KSP Residual norm 7.539889498211e-13 > > Line search: gnorm after quadratic fit 1.990589649135e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.542648241555e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm 1.436629416941e+02 lambda=1.1434720389464151e-02 > > 26 SNES Function norm 1.436629416941e+02 > > 0 KSP Residual norm 8.844861828477e+00 > > 1 KSP Residual norm 4.372001279689e-13 > > Line search: gnorm after quadratic fit 4.055598972133e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.990820671396e+02 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.436827663113e+02 lambda=6.3302081701296859e-03 > > Line search: Cubically determined step, current gnorm 1.434397789472e+02 lambda=3.1285674619640730e-03 > > 27 SNES Function norm 1.434397789472e+02 > > 0 KSP Residual norm 2.168630760128e+01 > > 1 KSP Residual norm 3.975838928402e-13 > > Line search: gnorm after quadratic fit 1.655681371309e+03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.972331169594e+02 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.804118272840e+02 lambda=1.6710557456633125e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.435928635079e+02 lambda=1.6710557456633126e-03 > > Line search: Cubically determined step, current gnorm 1.434032742903e+02 lambda=5.1357350159978810e-04 > > 28 SNES Function norm 1.434032742903e+02 > > 0 KSP Residual norm 5.259508821923e+01 > > 1 KSP Residual norm 1.358381204928e-11 > > Line search: gnorm after quadratic fit 1.908330224731e+04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.431279702545e+03 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.060945045253e+02 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.791318323447e+02 lambda=1.2124172979783788e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.491140019897e+02 lambda=2.6952165802905347e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434246250245e+02 lambda=2.6952165802905350e-04 > > Line search: Cubically determined step, current gnorm 1.433970449422e+02 lambda=8.6980371578986910e-05 > > 29 SNES Function norm 1.433970449422e+02 > > 0 KSP Residual norm 1.326287161615e+02 > > 1 KSP Residual norm 5.692176796134e-12 > > Line search: gnorm after quadratic fit 2.077891749832e+05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.654187989332e+04 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.213029457851e+03 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.001385334742e+03 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.323976827250e+02 lambda=5.9607661619885998e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.489839529892e+02 lambda=1.0476257410701045e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434396736634e+02 lambda=1.0476257410701046e-04 > > Line search: Cubically determined step, current gnorm 1.433960671821e+02 lambda=1.3664867646895530e-05 > > 30 SNES Function norm 1.433960671821e+02 > > 0 KSP Residual norm 3.320710360189e+02 > > 1 KSP Residual norm 1.365660123102e-11 > > Line search: gnorm after quadratic fit 3.597335441013e+06 > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.714766420450e+05 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.566809766217e+04 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.038660363150e+04 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.026997416957e+03 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.382653551072e+02 lambda=3.1250000000000002e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.071747386385e+02 lambda=1.3384948046761360e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.439693866777e+02 lambda=1.3384948046761360e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434000505249e+02 lambda=1.3384948046761361e-05 > > Line search: Cubically determined step, current gnorm 1.433959111179e+02 lambda=2.1771867000079373e-06 > > 31 SNES Function norm 1.433959111179e+02 > > 0 KSP Residual norm 8.385024273664e+02 > > 1 KSP Residual norm 2.688330817732e-11 > > Line search: gnorm after quadratic fit 5.487352481970e+07 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.776642694838e+06 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.310551423141e+05 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.023322644608e+05 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.368662233379e+04 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.472194884015e+03 lambda=3.1250000000000002e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.718801059897e+02 lambda=1.5625000000000001e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.274234972424e+02 lambda=6.3064412238487922e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.442194384053e+02 lambda=6.3064412238487925e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434033578642e+02 lambda=6.3064412238487927e-06 > > Line search: Cubically determined step, current gnorm 1.433959042208e+02 lambda=6.3064412238487929e-07 > > 32 SNES Function norm 1.433959042208e+02 > > 0 KSP Residual norm 5.310191626867e+02 > > 1 KSP Residual norm 2.270033897601e-10 > > Line search: gnorm after quadratic fit 1.447633783740e+07 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.859761774309e+06 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.472992503503e+05 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.557594026810e+04 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.969012939380e+03 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.269212161982e+03 lambda=3.1250000000000002e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.859005100842e+02 lambda=1.5625000000000001e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.695095262046e+02 lambda=5.4509037994531233e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.436389958907e+02 lambda=5.4509037994531237e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433976258223e+02 lambda=5.4509037994531242e-06 > > Line search: Cubically determined step, current gnorm 1.433958431980e+02 lambda=8.5124820362933632e-07 > > 33 SNES Function norm 1.433958431980e+02 > > 0 KSP Residual norm 1.341142541825e+03 > > 1 KSP Residual norm 4.194815344365e-11 > > Line search: gnorm after quadratic fit 2.256410317099e+08 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.797696259877e+07 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.447237377751e+06 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.221898175722e+05 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.260244723327e+04 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.539148524881e+03 lambda=3.1250000000000002e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.558034531173e+03 lambda=1.5625000000000001e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.788188892302e+02 lambda=7.8125000000000004e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.753621043454e+02 lambda=2.4427125599600652e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.437122397600e+02 lambda=2.4427125599600654e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433986985128e+02 lambda=2.4427125599600655e-06 > > Line search: Cubically determined step, current gnorm 1.433958402293e+02 lambda=2.4427125599600656e-07 > > 34 SNES Function norm 1.433958402293e+02 > > 0 KSP Residual norm 8.620962950418e+02 > > 1 KSP Residual norm 4.517777375659e-11 > > Line search: gnorm after quadratic fit 6.134442313460e+07 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.790495969255e+06 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.008365220843e+06 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.364572513478e+05 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.037891335918e+04 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.640571521199e+03 lambda=3.1250000000000002e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.472549649319e+02 lambda=1.5625000000000001e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.906041216274e+02 lambda=7.6348458761785112e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.504925859329e+02 lambda=1.7740973415567094e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434632637071e+02 lambda=1.7740973415567094e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433962847027e+02 lambda=1.7740973415567095e-06 > > Line search: Cubically determined step, current gnorm 1.433958170795e+02 lambda=3.2293255704969003e-07 > > 35 SNES Function norm 1.433958170795e+02 > > 0 KSP Residual norm 2.177497039945e+03 > > 1 KSP Residual norm 8.546235181505e-11 > > Line search: gnorm after quadratic fit 9.689178330938e+08 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.204850731541e+08 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.491460480376e+07 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.833699292784e+06 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.246639021599e+05 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.860166571872e+04 lambda=3.1250000000000002e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.484329051490e+03 lambda=1.5625000000000001e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.050411687443e+03 lambda=7.8125000000000004e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.488366972009e+02 lambda=3.7767265396089055e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.508326035050e+02 lambda=7.2725649346261757e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434696063559e+02 lambda=7.2725649346261764e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433964618996e+02 lambda=7.2725649346261768e-07 > > Line search: Cubically determined step, current gnorm 1.433958141405e+02 lambda=7.2725649346261771e-08 > > 36 SNES Function norm 1.433958141405e+02 > > 0 KSP Residual norm 2.164813477994e+03 > > 1 KSP Residual norm 1.148881458292e-10 > > Line search: gnorm after quadratic fit 9.626940870744e+08 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.210459267934e+08 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.531855101756e+07 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.966826097072e+06 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.611808255272e+05 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.746062783262e+04 lambda=3.1250000000000002e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.252259871244e+03 lambda=1.5625000000000001e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.319447372021e+03 lambda=7.8125000000000004e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.963055448218e+02 lambda=3.9062500000000002e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.719034797105e+02 lambda=1.3935000445038475e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.436664111092e+02 lambda=1.3935000445038476e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433983336239e+02 lambda=1.3935000445038476e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958213497e+02 lambda=1.3935000445038476e-07 > > Line search: Cubically determined step, current gnorm 1.433958104705e+02 lambda=5.1202466521517630e-08 > > 37 SNES Function norm 1.433958104705e+02 > > 0 KSP Residual norm 5.470482746849e+03 > > 1 KSP Residual norm 2.077456833170e-10 > > Line search: gnorm after quadratic fit 1.541335606193e+10 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.922526157954e+09 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.393079394383e+08 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.967573549050e+07 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.657319925168e+06 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.479516204895e+05 lambda=3.1250000000000002e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.573399122917e+04 lambda=1.5625000000000001e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.931177424479e+03 lambda=7.8125000000000004e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.619710606187e+03 lambda=3.9062500000000002e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.924551713717e+02 lambda=1.9531250000000001e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.786095404459e+02 lambda=6.2808469554243522e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.437467476469e+02 lambda=6.2808469554243527e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433992463439e+02 lambda=6.2808469554243527e-07 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958367271e+02 lambda=6.2808469554243525e-08 > > Line search: Cubically determined step, current gnorm 1.433958098948e+02 lambda=8.0208105170108588e-09 > > 38 SNES Function norm 1.433958098948e+02 > > 0 KSP Residual norm 1.380568582849e+04 > > 1 KSP Residual norm 3.830866223513e-10 > > Line search: gnorm after quadratic fit 2.484973518314e+11 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.108953896984e+10 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.893104137528e+09 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.884003910853e+08 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.150765563542e+07 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.811161146103e+06 lambda=3.1250000000000002e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.011017986781e+06 lambda=1.5625000000000001e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.368084343451e+05 lambda=7.8125000000000004e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.042876665700e+04 lambda=3.9062500000000002e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.648735196752e+03 lambda=1.9531250000000001e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.489051252413e+02 lambda=9.7656250000000005e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.910677756717e+02 lambda=4.7728537787817724e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.505452645186e+02 lambda=1.1099980464343249e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434658984864e+02 lambda=1.1099980464343249e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433964956476e+02 lambda=1.1099980464343249e-07 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958153212e+02 lambda=1.1099980464343250e-08 > > Line search: Cubically determined step, current gnorm 1.433958098048e+02 lambda=1.2587012037197021e-09 > > 39 SNES Function norm 1.433958098048e+02 > > 0 KSP Residual norm 3.492284741552e+04 > > 1 KSP Residual norm 2.459788921244e-09 > > Line search: gnorm after quadratic fit 4.017424324975e+12 > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.020053801097e+11 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.270768402853e+10 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.827801904036e+09 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.758550488105e+08 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.213492627852e+08 lambda=3.1250000000000002e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.502191365805e+07 lambda=1.5625000000000001e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.846947104704e+06 lambda=7.8125000000000004e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.262850216093e+05 lambda=3.9062500000000002e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.879926646684e+04 lambda=1.9531250000000001e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.510203332079e+03 lambda=9.7656250000000005e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.055028679619e+03 lambda=4.8828125000000003e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.503903269554e+02 lambda=2.3633949212111800e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.510245991472e+02 lambda=4.5897967908360529e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434724062782e+02 lambda=4.5897967908360533e-07 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433965706606e+02 lambda=4.5897967908360533e-08 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958168196e+02 lambda=4.5897967908360538e-09 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958098155e+02 lambda=4.5897967908360540e-10 > > Line search: Cubically determined step, current gnorm 1.433958097906e+02 lambda=1.9745369723997599e-10 > > 40 SNES Function norm 1.433958097906e+02 > > 0 KSP Residual norm 8.722495521587e+04 > > 1 KSP Residual norm 3.742695919275e-09 > > Line search: gnorm after quadratic fit 6.262538457180e+13 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.829256308992e+12 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.789282877890e+11 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.224340679566e+11 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.532137613500e+10 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.919506047737e+09 lambda=3.1250000000000002e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.410488718338e+08 lambda=1.5625000000000001e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.042211373104e+07 lambda=7.8125000000000004e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.881986305609e+06 lambda=3.9062500000000002e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.080857001861e+05 lambda=1.9531250000000001e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.054449734307e+04 lambda=9.7656250000000005e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.109051581397e+04 lambda=4.8828125000000003e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.144985497099e+03 lambda=2.4414062500000001e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.617627947761e+02 lambda=1.2207031250000001e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.132828960986e+02 lambda=5.3137869181552773e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.440403409760e+02 lambda=5.3137869181552777e-07 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434022226216e+02 lambda=5.3137869181552781e-08 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958732177e+02 lambda=5.3137869181552781e-09 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958103569e+02 lambda=5.3137869181552779e-10 > > Line search: Cubically determined step, current gnorm 1.433958097894e+02 lambda=5.3137869181552781e-11 > > 41 SNES Function norm 1.433958097894e+02 > > 0 KSP Residual norm 6.453169081212e+04 > > 1 KSP Residual norm 2.762540688686e-09 > > Line search: gnorm after quadratic fit 2.535166112592e+13 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.168366990040e+12 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.958985371462e+11 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.945064622488e+10 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.172244865713e+09 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.693002384290e+08 lambda=3.1250000000000002e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.562568994785e+07 lambda=1.5625000000000001e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.182957296890e+07 lambda=7.8125000000000004e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.453260254263e+06 lambda=3.9062500000000002e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.781984147743e+05 lambda=1.9531250000000001e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.294934468515e+04 lambda=9.7656250000000005e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.740461720782e+03 lambda=4.8828125000000003e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.162621855154e+02 lambda=2.4414062500000001e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.042417294890e+02 lambda=1.1290474210136388e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.458920680477e+02 lambda=1.4201366604660443e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434208620254e+02 lambda=1.4201366604660444e-07 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433960586269e+02 lambda=1.4201366604660445e-08 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958120934e+02 lambda=1.4201366604660445e-09 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958097940e+02 lambda=1.4201366604660446e-10 > > Line search: Cubically determined step, current gnorm 1.433958097852e+02 lambda=5.7981795207229486e-11 > > 42 SNES Function norm 1.433958097852e+02 > > 0 KSP Residual norm 1.596625793747e+05 > > 1 KSP Residual norm 6.465899717071e-09 > > Line search: gnorm after quadratic fit 3.840699863976e+14 > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.801237514773e+13 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.002454410823e+12 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.505340831651e+11 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.387378188418e+10 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.174857842415e+10 lambda=3.1250000000000002e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.472211181784e+09 lambda=1.5625000000000001e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.849608933788e+08 lambda=7.8125000000000004e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.336592011613e+07 lambda=3.9062500000000002e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.988079805895e+06 lambda=1.9531250000000001e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.930858080425e+05 lambda=9.7656250000000005e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.521190722497e+04 lambda=4.8828125000000003e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.872153015323e+03 lambda=2.4414062500000001e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.772337662956e+03 lambda=1.2207031250000001e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.879470852054e+02 lambda=6.1035156250000003e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.942774855488e+02 lambda=2.4957912736226801e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.438719078958e+02 lambda=2.4957912736226800e-07 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434005516391e+02 lambda=2.4957912736226800e-08 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958568732e+02 lambda=2.4957912736226803e-09 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958102244e+02 lambda=2.4957912736226804e-10 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958097865e+02 lambda=2.4957912736226805e-11 > > Line search: Cubically determined step, current gnorm 1.433958097846e+02 lambda=9.2900433293108317e-12 > > 43 SNES Function norm 1.433958097846e+02 > > 0 KSP Residual norm 4.230869747157e+05 > > 1 KSP Residual norm 2.238707423027e-08 > > Line search: gnorm after quadratic fit 7.145700515048e+15 > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.931871281700e+14 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.116420341041e+14 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.395366610168e+13 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.743811756566e+12 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.178776103292e+11 lambda=3.1250000000000002e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.721012032848e+10 lambda=1.5625000000000001e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.395186924428e+09 lambda=7.8125000000000004e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.229125978585e+08 lambda=3.9062500000000002e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.250971135953e+07 lambda=1.9531250000000001e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.483856203094e+06 lambda=9.7656250000000005e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.950671355228e+05 lambda=4.8828125000000003e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.795408218555e+04 lambda=2.4414062500000001e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.315025696280e+04 lambda=1.2207031250000001e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.395961070555e+03 lambda=6.1035156250000003e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.565070307576e+02 lambda=3.0517578125000002e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.228949713871e+02 lambda=1.2154989071946628e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.441831998014e+02 lambda=1.2154989071946629e-07 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434037055996e+02 lambda=1.2154989071946630e-08 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958886074e+02 lambda=1.2154989071946630e-09 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958105564e+02 lambda=1.2154989071946630e-10 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958097907e+02 lambda=1.2154989071946631e-11 > > Line search: Cubically determined step, current gnorm 1.433958097845e+02 lambda=1.3559489351735629e-12 > > 44 SNES Function norm 1.433958097845e+02 > > 0 KSP Residual norm 1.017589039922e+06 > > 1 KSP Residual norm 5.483283808994e-08 > > Line search: gnorm after quadratic fit 9.942386816509e+16 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.242813073279e+16 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.553553149772e+15 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.942033483320e+14 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.427772097758e+13 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.035291372732e+12 lambda=3.1250000000000002e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.795558047824e+11 lambda=1.5625000000000001e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.748073147307e+10 lambda=7.8125000000000004e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.944235240368e+09 lambda=3.9062500000000002e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.453550734860e+08 lambda=1.9531250000000001e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.377045707707e+07 lambda=9.7656250000000005e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.188119937132e+07 lambda=4.8828125000000003e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.529730353136e+06 lambda=2.4414062500000001e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.044646611329e+05 lambda=1.2207031250000001e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.974477616118e+04 lambda=6.1035156250000003e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.087923877078e+03 lambda=3.0517578125000002e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.112257173311e+03 lambda=1.5258789062500001e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.536190077033e+02 lambda=7.6293945312500004e-07 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.622567424729e+02 lambda=2.4244966960965791e-07 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.435780438142e+02 lambda=2.4244966960965793e-08 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433976282603e+02 lambda=2.4244966960965796e-09 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958279382e+02 lambda=2.4244966960965797e-10 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958099632e+02 lambda=2.4244966960965799e-11 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958097860e+02 lambda=2.4244966960965801e-12 > > Line search: Cubically determined step, current gnorm 1.433958097845e+02 lambda=2.4244966960965801e-13 > > 45 SNES Function norm 1.433958097845e+02 > > 0 KSP Residual norm 2.206687220910e+06 > > 1 KSP Residual norm 4.897651438902e-08 > > Line search: gnorm after quadratic fit 1.013883843512e+18 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.267347883019e+17 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.584167551460e+16 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.980166189110e+15 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.475099638694e+14 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.093604443378e+13 lambda=3.1250000000000002e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.866330988164e+12 lambda=1.5625000000000001e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.831230804145e+11 lambda=7.8125000000000004e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.034848618023e+10 lambda=3.9062500000000002e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.533173457427e+09 lambda=1.9531250000000001e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.390937545910e+08 lambda=9.7656250000000005e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.167706366282e+08 lambda=4.8828125000000003e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.445357932595e+07 lambda=2.4414062500000001e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.776833600920e+06 lambda=1.2207031250000001e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.177171496134e+05 lambda=6.1035156250000003e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.775750596740e+04 lambda=3.0517578125000002e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.374283858049e+03 lambda=1.5258789062500001e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.030949543491e+03 lambda=7.6293945312500004e-07 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.423064811256e+02 lambda=3.6673216108643130e-07 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.499924205417e+02 lambda=6.7541706529544844e-08 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434620968378e+02 lambda=6.7541706529544851e-09 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433964732224e+02 lambda=6.7541706529544853e-10 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958164087e+02 lambda=6.7541706529544856e-11 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958098496e+02 lambda=6.7541706529544860e-12 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958097850e+02 lambda=6.7541706529544869e-13 > > Line search: unable to find good step length! After 24 tries > > Line search: fnorm=1.4339580978447020e+02, gnorm=1.4339580978501337e+02, ynorm=2.2066872446260620e+06, minlambda=9.9999999999999998e-13, lambda=6.7541706529544869e-13, initial slope=-2.0562359199040133e+04 > > 0 SNES Function norm 7.494832241120e+03 > > 0 KSP Residual norm 2.096735360816e+01 > > 1 KSP Residual norm 1.310027756820e-12 > > Line search: gnorm after quadratic fit 6.728375857515e+03 > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > 1 SNES Function norm 6.728375857515e+03 > > 0 KSP Residual norm 2.051806116405e+01 > > 1 KSP Residual norm 4.624620138831e-13 > > Line search: gnorm after quadratic fit 6.028616261650e+03 > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > 2 SNES Function norm 6.028616261650e+03 > > 0 KSP Residual norm 2.416503160016e+01 > > 1 KSP Residual norm 8.456041680630e-13 > > Line search: gnorm after quadratic fit 5.407473517447e+03 > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > 3 SNES Function norm 5.407473517447e+03 > > 0 KSP Residual norm 1.429873750399e+01 > > 1 KSP Residual norm 2.956316145819e-13 > > Line search: Using full step: fnorm 5.407473517447e+03 gnorm 1.894530516076e+03 > > 4 SNES Function norm 1.894530516076e+03 > > 0 KSP Residual norm 2.898580554597e+00 > > 1 KSP Residual norm 6.622560162623e-14 > > Line search: Using full step: fnorm 1.894530516076e+03 gnorm 1.794029421846e+03 > > 5 SNES Function norm 1.794029421846e+03 > > 0 KSP Residual norm 1.749678611959e+01 > > 1 KSP Residual norm 8.138905825078e-12 > > Line search: gnorm after quadratic fit 1.767361408940e+03 > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > 6 SNES Function norm 1.767361408940e+03 > > 0 KSP Residual norm 1.094404109423e+02 > > 1 KSP Residual norm 7.696691527700e-12 > > Line search: gnorm after quadratic fit 3.545750923895e+04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.153479540314e+03 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.205683629874e+03 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.802976525485e+03 lambda=1.2441094586006883e-02 > > Line search: Cubically determined step, current gnorm 1.765063299263e+03 lambda=4.9240328094708914e-03 > > 7 SNES Function norm 1.765063299263e+03 > > 0 KSP Residual norm 1.778095975189e+01 > > 1 KSP Residual norm 2.814661813934e-12 > > Line search: gnorm after quadratic fit 2.620761680117e+03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.793045753271e+03 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm 1.740299227935e+03 lambda=2.5000000000000001e-02 > > 8 SNES Function norm 1.740299227935e+03 > > 0 KSP Residual norm 3.284236894535e+02 > > 1 KSP Residual norm 5.172103783952e-10 > > Line search: gnorm after quadratic fit 2.857820523902e+05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.063993491139e+04 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.588139591650e+03 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.491163684413e+03 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.802614760566e+03 lambda=5.7977212395253904e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.741444490992e+03 lambda=1.8448315876950813e-03 > > Line search: Cubically determined step, current gnorm 1.739663656043e+03 lambda=7.7468345598227730e-04 > > 9 SNES Function norm 1.739663656043e+03 > > 0 KSP Residual norm 4.581839103558e+02 > > 1 KSP Residual norm 2.627035885943e-11 > > Line search: gnorm after quadratic fit 8.199478499066e+05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.127270076812e+05 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.816774161281e+04 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.053723877333e+03 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.971814513392e+03 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.755066208174e+03 lambda=2.7232010924558834e-03 > > Line search: Cubically determined step, current gnorm 1.739559834479e+03 lambda=8.1458417855297680e-04 > > 10 SNES Function norm 1.739559834479e+03 > > 0 KSP Residual norm 1.463056810139e+02 > > 1 KSP Residual norm 5.383584598825e-12 > > Line search: gnorm after quadratic fit 2.885699620595e+04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.847717401708e+03 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.244464170034e+03 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.769157604338e+03 lambda=1.0857209099577540e-02 > > Line search: Cubically determined step, current gnorm 1.737356225452e+03 lambda=4.0312937622950231e-03 > > 11 SNES Function norm 1.737356225452e+03 > > 0 KSP Residual norm 1.564105677925e+02 > > 1 KSP Residual norm 6.671164745832e-11 > > Line search: gnorm after quadratic fit 3.815800291873e+04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.197027796134e+03 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.373151605545e+03 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.783976520867e+03 lambda=1.2093374970461970e-02 > > Line search: Cubically determined step, current gnorm 1.735737929915e+03 lambda=4.9529698477569920e-03 > > 12 SNES Function norm 1.735737929915e+03 > > 0 KSP Residual norm 5.030757139645e+01 > > 1 KSP Residual norm 1.157542730692e-12 > > Line search: gnorm after quadratic fit 3.004544441458e+03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.850403239750e+03 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm 1.722893188305e+03 lambda=2.0881992439921702e-02 > > 13 SNES Function norm 1.722893188305e+03 > > 0 KSP Residual norm 7.123428853845e+01 > > 1 KSP Residual norm 8.671726774894e-12 > > Line search: gnorm after quadratic fit 4.361041499279e+03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.032697222107e+03 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.726212330814e+03 lambda=1.9909470348267504e-02 > > Line search: Cubically determined step, current gnorm 1.714127356920e+03 lambda=9.9547351741337518e-03 > > 14 SNES Function norm 1.714127356920e+03 > > 0 KSP Residual norm 8.304557447257e+00 > > 1 KSP Residual norm 6.268295862688e-13 > > Line search: gnorm after quadratic fit 1.558163002487e+03 > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > 15 SNES Function norm 1.558163002487e+03 > > 0 KSP Residual norm 2.820803287164e+00 > > 1 KSP Residual norm 5.477413853752e-13 > > Line search: gnorm after quadratic fit 1.065673478530e+03 > > Line search: Quadratically determined step, lambda=3.8943438938591052e-01 > > 16 SNES Function norm 1.065673478530e+03 > > 0 KSP Residual norm 2.296739120664e+00 > > 1 KSP Residual norm 6.273731899885e-14 > > Line search: gnorm after quadratic fit 8.964342150621e+02 > > Line search: Quadratically determined step, lambda=1.8740736900935545e-01 > > 17 SNES Function norm 8.964342150621e+02 > > 0 KSP Residual norm 5.567568505830e+00 > > 1 KSP Residual norm 8.649083600764e-12 > > Line search: gnorm after quadratic fit 8.322514858992e+02 > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > 18 SNES Function norm 8.322514858992e+02 > > 0 KSP Residual norm 1.164393577210e+00 > > 1 KSP Residual norm 2.019248309015e-14 > > Line search: Using full step: fnorm 8.322514858992e+02 gnorm 3.179750274746e+02 > > 19 SNES Function norm 3.179750274746e+02 > > 0 KSP Residual norm 5.339294310641e+00 > > 1 KSP Residual norm 2.070321587238e-13 > > Line search: gnorm after quadratic fit 3.433012316833e+02 > > Line search: Cubically determined step, current gnorm 3.140305403821e+02 lambda=5.0000000000000003e-02 > > 20 SNES Function norm 3.140305403821e+02 > > 0 KSP Residual norm 1.177016565578e+01 > > 1 KSP Residual norm 2.413027540446e-13 > > Line search: gnorm after quadratic fit 7.377851778409e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.896721016582e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm 3.136619309181e+02 lambda=9.7219892278716195e-03 > > 21 SNES Function norm 3.136619309181e+02 > > 0 KSP Residual norm 3.973565083977e+00 > > 1 KSP Residual norm 9.726786674410e-14 > > Line search: gnorm after quadratic fit 3.098277326090e+02 > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > 22 SNES Function norm 3.098277326090e+02 > > 0 KSP Residual norm 9.389290683519e+00 > > 1 KSP Residual norm 1.651497163724e-13 > > Line search: gnorm after quadratic fit 6.887970540455e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.588146381477e+02 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.099274823603e+02 lambda=1.6890426151283184e-02 > > Line search: Cubically determined step, current gnorm 3.084890760827e+02 lambda=8.4452130756415920e-03 > > 23 SNES Function norm 3.084890760827e+02 > > 0 KSP Residual norm 2.381130479641e+00 > > 1 KSP Residual norm 4.694489283156e-14 > > Line search: gnorm after quadratic fit 2.872151876535e+02 > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > 24 SNES Function norm 2.872151876535e+02 > > 0 KSP Residual norm 2.405498502269e+00 > > 1 KSP Residual norm 3.316846070538e-13 > > Line search: gnorm after quadratic fit 2.686789761232e+02 > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > 25 SNES Function norm 2.686789761232e+02 > > 0 KSP Residual norm 1.728772970554e+00 > > 1 KSP Residual norm 4.132974383339e-14 > > Line search: gnorm after quadratic fit 2.365009918229e+02 > > Line search: Quadratically determined step, lambda=1.7273357529379074e-01 > > 26 SNES Function norm 2.365009918229e+02 > > 0 KSP Residual norm 4.413764759374e+00 > > 1 KSP Residual norm 5.210690816917e-14 > > Line search: gnorm after quadratic fit 2.756730968257e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.372321757171e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm 2.335020811250e+02 lambda=2.5000000000000001e-02 > > 27 SNES Function norm 2.335020811250e+02 > > 0 KSP Residual norm 1.606246507553e+00 > > 1 KSP Residual norm 3.564847846678e-14 > > Line search: gnorm after quadratic fit 2.078263630653e+02 > > Line search: Quadratically determined step, lambda=1.5913860995949433e-01 > > 28 SNES Function norm 2.078263630653e+02 > > 0 KSP Residual norm 3.700632954873e+00 > > 1 KSP Residual norm 5.113863400264e-13 > > Line search: gnorm after quadratic fit 2.142503514807e+02 > > Line search: Cubically determined step, current gnorm 2.021095009118e+02 lambda=5.0000000000000003e-02 > > 29 SNES Function norm 2.021095009118e+02 > > 0 KSP Residual norm 3.056449560135e+00 > > 1 KSP Residual norm 3.207987681334e-14 > > Line search: gnorm after quadratic fit 2.064252530802e+02 > > Line search: Cubically determined step, current gnorm 1.978069081639e+02 lambda=5.0000000000000003e-02 > > 30 SNES Function norm 1.978069081639e+02 > > 0 KSP Residual norm 2.024695620703e+00 > > 1 KSP Residual norm 5.460360737995e-14 > > Line search: gnorm after quadratic fit 1.839556530796e+02 > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > 31 SNES Function norm 1.839556530796e+02 > > 0 KSP Residual norm 1.610676619931e+01 > > 1 KSP Residual norm 6.703552136307e-13 > > Line search: gnorm after quadratic fit 7.186735314913e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.905672430097e+02 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.856766286600e+02 lambda=1.0830798014298563e-02 > > Line search: Cubically determined step, current gnorm 1.836818937131e+02 lambda=3.3207362501459785e-03 > > 32 SNES Function norm 1.836818937131e+02 > > 0 KSP Residual norm 7.471722173131e+01 > > 1 KSP Residual norm 2.671534648829e-12 > > Line search: gnorm after quadratic fit 9.613379909411e+04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.509491298762e+04 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.808861367705e+03 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.767283758299e+02 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.665421328348e+02 lambda=6.0369453941238101e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.869726717041e+02 lambda=1.4394327006264963e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.836897704575e+02 lambda=1.4394327006264963e-04 > > Line search: Cubically determined step, current gnorm 1.836767951408e+02 lambda=5.5567420418543164e-05 > > 33 SNES Function norm 1.836767951408e+02 > > 0 KSP Residual norm 2.702367712138e+01 > > 1 KSP Residual norm 2.731656687850e-12 > > Line search: gnorm after quadratic fit 3.331563146098e+03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.723694790688e+02 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.941243220944e+02 lambda=2.1443568774664485e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.847231733910e+02 lambda=2.7571330376860012e-03 > > Line search: Cubically determined step, current gnorm 1.836356729409e+02 lambda=4.7841280418270480e-04 > > 34 SNES Function norm 1.836356729409e+02 > > 0 KSP Residual norm 1.228333177997e+01 > > 1 KSP Residual norm 2.681127387880e-13 > > Line search: gnorm after quadratic fit 6.936329223475e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.749327218775e+02 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.871557327742e+02 lambda=1.4160505301999991e-02 > > Line search: Cubically determined step, current gnorm 1.833523080682e+02 lambda=3.5196326548579192e-03 > > 35 SNES Function norm 1.833523080682e+02 > > 0 KSP Residual norm 3.531886257396e+02 > > 1 KSP Residual norm 2.364634092895e-11 > > Line search: gnorm after quadratic fit 3.994783047929e+06 > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.753715960726e+05 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.516669898185e+04 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.918985942348e+03 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.363599250418e+03 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.344906818752e+02 lambda=3.1250000000000002e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.991088183980e+02 lambda=1.0108094710462592e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.834621681844e+02 lambda=1.0108094710462593e-04 > > Line search: Cubically determined step, current gnorm 1.833517377324e+02 lambda=1.0108094710462594e-05 > > 36 SNES Function norm 1.833517377324e+02 > > 0 KSP Residual norm 9.005833507118e+01 > > 1 KSP Residual norm 6.116387880629e-12 > > Line search: gnorm after quadratic fit 8.899847103226e+04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.388111536526e+04 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.532652074749e+03 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.864912734009e+02 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.421068789960e+02 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.873498120960e+02 lambda=2.1924025345283278e-03 > > Line search: Cubically determined step, current gnorm 1.833506987706e+02 lambda=2.1924025345283280e-04 > > 37 SNES Function norm 1.833506987706e+02 > > 0 KSP Residual norm 1.548426525207e+01 > > 1 KSP Residual norm 1.038038773942e-12 > > Line search: gnorm after quadratic fit 6.702848665441e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.789880616078e+02 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.846521504351e+02 lambda=1.0567302644323170e-02 > > Line search: Cubically determined step, current gnorm 1.830548481815e+02 lambda=3.5274490352771972e-03 > > 38 SNES Function norm 1.830548481815e+02 > > 0 KSP Residual norm 1.523095478807e+01 > > 1 KSP Residual norm 1.963823596119e-12 > > Line search: gnorm after quadratic fit 9.255727478491e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.496757253461e+02 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.863126241242e+02 lambda=9.3143291632966311e-03 > > Line search: Cubically determined step, current gnorm 1.829091761403e+02 lambda=1.8107234819462800e-03 > > 39 SNES Function norm 1.829091761403e+02 > > 0 KSP Residual norm 1.311320726934e+01 > > 1 KSP Residual norm 9.084170520902e-13 > > Line search: gnorm after quadratic fit 7.488610069188e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.691148243365e+02 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.885558228772e+02 lambda=1.9439894235886539e-02 > > Line search: Cubically determined step, current gnorm 1.825540619134e+02 lambda=5.4967824488704169e-03 > > 40 SNES Function norm 1.825540619134e+02 > > 0 KSP Residual norm 1.218635557505e+01 > > 1 KSP Residual norm 7.760485728617e-13 > > Line search: gnorm after quadratic fit 6.636453826807e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.880828006022e+02 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.830493790584e+02 lambda=6.6234802648049863e-03 > > Line search: Cubically determined step, current gnorm 1.823397545268e+02 lambda=2.4308217464828865e-03 > > 41 SNES Function norm 1.823397545268e+02 > > 0 KSP Residual norm 9.456543593865e+00 > > 1 KSP Residual norm 7.046593270309e-13 > > Line search: gnorm after quadratic fit 3.369769163110e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.105230957789e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm 1.817897533119e+02 lambda=9.1612481372917148e-03 > > 42 SNES Function norm 1.817897533119e+02 > > 0 KSP Residual norm 7.290035145805e+00 > > 1 KSP Residual norm 3.198962158141e-12 > > Line search: gnorm after quadratic fit 2.858311567415e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.965004842981e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm 1.808845577764e+02 lambda=1.3826421990147811e-02 > > 43 SNES Function norm 1.808845577764e+02 > > 0 KSP Residual norm 7.256785036157e+00 > > 1 KSP Residual norm 9.243179217625e-14 > > Line search: gnorm after quadratic fit 2.534388176390e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.916726818893e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm 1.797953125543e+02 lambda=1.3677747819164022e-02 > > 44 SNES Function norm 1.797953125543e+02 > > 0 KSP Residual norm 1.716201096352e+01 > > 1 KSP Residual norm 2.701418800808e-13 > > Line search: gnorm after quadratic fit 1.331064301474e+03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.461842246267e+02 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.920668830294e+02 lambda=1.2856504859057132e-02 > > Line search: Cubically determined step, current gnorm 1.797121460957e+02 lambda=1.4396611381500967e-03 > > 45 SNES Function norm 1.797121460957e+02 > > 0 KSP Residual norm 6.613432967985e+00 > > 1 KSP Residual norm 1.357752977076e-13 > > Line search: gnorm after quadratic fit 2.721288927858e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.939638282615e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm 1.787985482018e+02 lambda=1.2647907914070569e-02 > > 46 SNES Function norm 1.787985482018e+02 > > 0 KSP Residual norm 1.225736349281e+01 > > 1 KSP Residual norm 3.819378790812e-13 > > Line search: gnorm after quadratic fit 4.548006065036e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.304803559060e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm 1.787344729174e+02 lambda=8.9002284237256531e-03 > > 47 SNES Function norm 1.787344729174e+02 > > 0 KSP Residual norm 6.302465402340e+00 > > 1 KSP Residual norm 6.980931947122e-14 > > Line search: gnorm after quadratic fit 2.879477700004e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.980806946742e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm 1.780128006935e+02 lambda=1.0223293444602008e-02 > > 48 SNES Function norm 1.780128006935e+02 > > 0 KSP Residual norm 4.323829277968e+00 > > 1 KSP Residual norm 5.223881369308e-13 > > Line search: gnorm after quadratic fit 1.957928151218e+02 > > Line search: Cubically determined step, current gnorm 1.768899805640e+02 lambda=5.0000000000000003e-02 > > 49 SNES Function norm 1.768899805640e+02 > > 0 KSP Residual norm 2.249256107033e+00 > > 1 KSP Residual norm 3.624400957270e-14 > > Line search: gnorm after quadratic fit 1.704782114773e+02 > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > 50 SNES Function norm 1.704782114773e+02 > > 0 SNES Function norm 3.513783397332e+03 > > 0 KSP Residual norm 1.650214950648e+01 > > 1 KSP Residual norm 3.574269752690e-13 > > Line search: gnorm after quadratic fit 3.155830404050e+03 > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > 1 SNES Function norm 3.155830404050e+03 > > 0 KSP Residual norm 1.443734018042e+01 > > 1 KSP Residual norm 3.685565191058e-13 > > Line search: Using full step: fnorm 3.155830404050e+03 gnorm 8.581212204155e+02 > > 2 SNES Function norm 8.581212204155e+02 > > 0 KSP Residual norm 2.492601775565e+00 > > 1 KSP Residual norm 9.698440210389e-14 > > Line search: Using full step: fnorm 8.581212204155e+02 gnorm 7.018609898542e+02 > > 3 SNES Function norm 7.018609898542e+02 > > 0 KSP Residual norm 1.740320986421e+00 > > 1 KSP Residual norm 2.868780682435e-14 > > Line search: Using full step: fnorm 7.018609898542e+02 gnorm 2.135824235887e+02 > > 4 SNES Function norm 2.135824235887e+02 > > 0 KSP Residual norm 1.647413497077e+00 > > 1 KSP Residual norm 2.731226225666e-14 > > Line search: gnorm after quadratic fit 1.936469032649e+02 > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > 5 SNES Function norm 1.936469032649e+02 > > 0 KSP Residual norm 1.406615972124e+00 > > 1 KSP Residual norm 3.167179626699e-14 > > Line search: gnorm after quadratic fit 1.755362571467e+02 > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > 6 SNES Function norm 1.755362571467e+02 > > 0 KSP Residual norm 1.480681706594e+00 > > 1 KSP Residual norm 2.935210968935e-14 > > Line search: gnorm after quadratic fit 1.597659506616e+02 > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > 7 SNES Function norm 1.597659506616e+02 > > 0 KSP Residual norm 4.013154698097e+00 > > 1 KSP Residual norm 1.021628704832e-13 > > Line search: gnorm after quadratic fit 1.728408060966e+02 > > Line search: Cubically determined step, current gnorm 1.570815760721e+02 lambda=5.0000000000000003e-02 > > 8 SNES Function norm 1.570815760721e+02 > > 0 KSP Residual norm 1.510335662636e+00 > > 1 KSP Residual norm 2.728243244724e-14 > > Line search: gnorm after quadratic fit 1.450162880692e+02 > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > 9 SNES Function norm 1.450162880692e+02 > > 0 KSP Residual norm 1.923349271077e+01 > > 1 KSP Residual norm 1.640711956406e-11 > > Line search: gnorm after quadratic fit 1.016537223115e+03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.584263092048e+02 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.490729346583e+02 lambda=9.3725990358703350e-03 > > Line search: Cubically determined step, current gnorm 1.449349273006e+02 lambda=1.5464889706033082e-03 > > 10 SNES Function norm 1.449349273006e+02 > > 0 KSP Residual norm 1.154999084194e+01 > > 1 KSP Residual norm 1.292167633338e-11 > > Line search: gnorm after quadratic fit 6.060386918705e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.236630526035e+02 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.491201927819e+02 lambda=1.6816056300124185e-02 > > Line search: Cubically determined step, current gnorm 1.447023047013e+02 lambda=4.1484374564153808e-03 > > 11 SNES Function norm 1.447023047013e+02 > > 0 KSP Residual norm 7.278906180502e+00 > > 1 KSP Residual norm 2.815632651924e-12 > > Line search: gnorm after quadratic fit 2.512278711773e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.624350957814e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm 1.441656049510e+02 lambda=1.0879389002513012e-02 > > 12 SNES Function norm 1.441656049510e+02 > > 0 KSP Residual norm 4.449836480267e+00 > > 1 KSP Residual norm 3.152365624813e-13 > > Line search: gnorm after quadratic fit 1.749680739878e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.458763435996e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm 1.425715025152e+02 lambda=2.2766809271842225e-02 > > 13 SNES Function norm 1.425715025152e+02 > > 0 KSP Residual norm 4.218495037726e+00 > > 1 KSP Residual norm 1.398472536142e-12 > > Line search: gnorm after quadratic fit 1.645159536467e+02 > > Line search: Cubically determined step, current gnorm 1.421991559212e+02 lambda=4.1883769431247941e-02 > > 14 SNES Function norm 1.421991559212e+02 > > 0 KSP Residual norm 1.968853538608e+00 > > 1 KSP Residual norm 7.594023450519e-12 > > Line search: gnorm after quadratic fit 1.350960142124e+02 > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > 15 SNES Function norm 1.350960142124e+02 > > 0 KSP Residual norm 3.444721686085e+00 > > 1 KSP Residual norm 5.312609674019e-14 > > Line search: gnorm after quadratic fit 1.472880565107e+02 > > Line search: Cubically determined step, current gnorm 1.336714620145e+02 lambda=4.1341550820829437e-02 > > 16 SNES Function norm 1.336714620145e+02 > > 0 KSP Residual norm 3.276288899397e+00 > > 1 KSP Residual norm 8.394674946715e-14 > > Line search: gnorm after quadratic fit 1.459274497150e+02 > > Line search: Cubically determined step, current gnorm 1.327618539486e+02 lambda=5.0000000000000003e-02 > > 17 SNES Function norm 1.327618539486e+02 > > 0 KSP Residual norm 2.630052244303e+00 > > 1 KSP Residual norm 4.351283410507e-14 > > Line search: gnorm after quadratic fit 1.350378060116e+02 > > Line search: Cubically determined step, current gnorm 1.299403903934e+02 lambda=4.9913529436269283e-02 > > 18 SNES Function norm 1.299403903934e+02 > > 0 KSP Residual norm 6.124953430138e+00 > > 1 KSP Residual norm 2.295381352938e-13 > > Line search: gnorm after quadratic fit 2.275621676963e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.469611730657e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm 1.294890694898e+02 lambda=1.0071939100661648e-02 > > 19 SNES Function norm 1.294890694898e+02 > > 0 KSP Residual norm 1.036733907011e+01 > > 1 KSP Residual norm 1.800941381283e-13 > > Line search: gnorm after quadratic fit 3.844879463595e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.875071148504e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm 1.294494430642e+02 lambda=5.0000000000000010e-03 > > 20 SNES Function norm 1.294494430642e+02 > > 0 KSP Residual norm 8.224001595443e+00 > > 1 KSP Residual norm 3.337810156182e-13 > > Line search: gnorm after quadratic fit 3.332325263497e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.682441841234e+02 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.294720538860e+02 lambda=8.5401597581228530e-03 > > Line search: Cubically determined step, current gnorm 1.291762382985e+02 lambda=4.2555418164960989e-03 > > 21 SNES Function norm 1.291762382985e+02 > > 0 KSP Residual norm 3.920749219860e+01 > > 1 KSP Residual norm 1.610902886435e-12 > > Line search: gnorm after quadratic fit 3.472422440640e+03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.023065712859e+03 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.228184088700e+02 lambda=1.6004598823093592e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.298607525058e+02 lambda=1.6004598823093593e-03 > > Line search: Cubically determined step, current gnorm 1.291643460998e+02 lambda=1.9319076533745672e-04 > > 22 SNES Function norm 1.291643460998e+02 > > 0 KSP Residual norm 1.520092314848e+02 > > 1 KSP Residual norm 7.089159192434e-11 > > Line search: gnorm after quadratic fit 2.752539686422e+05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.237188995536e+04 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.484370498858e+03 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.571039994484e+03 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.280898858362e+02 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.708927009106e+02 lambda=2.6114913411793973e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.294919567784e+02 lambda=2.6114913411793975e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291645609810e+02 lambda=2.6114913411793977e-05 > > Line search: Cubically determined step, current gnorm 1.291635530596e+02 lambda=1.2278773895355162e-05 > > 23 SNES Function norm 1.291635530596e+02 > > 0 KSP Residual norm 7.569206058965e+02 > > 1 KSP Residual norm 3.454693729751e-11 > > Line search: gnorm after quadratic fit 2.570888738395e+07 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.064965025187e+06 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.498514098182e+05 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.807487005202e+04 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.233167830543e+03 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.396736912757e+03 lambda=3.1250000000000002e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.547572543330e+02 lambda=1.2623406091699435e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.335889024473e+02 lambda=1.8542137907683829e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.292059042479e+02 lambda=1.8542137907683831e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291637618568e+02 lambda=1.8542137907683832e-06 > > Line search: Cubically determined step, current gnorm 1.291635210734e+02 lambda=4.9524172913414387e-07 > > 24 SNES Function norm 1.291635210734e+02 > > 0 KSP Residual norm 3.761913422861e+03 > > 1 KSP Residual norm 6.181718776929e-10 > > Line search: gnorm after quadratic fit 3.342370445037e+09 > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.218326646111e+08 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.375128803204e+07 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.980626157021e+06 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.407418671219e+05 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.357321025399e+05 lambda=3.1250000000000002e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.188948059047e+04 lambda=1.5625000000000001e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.105117929713e+03 lambda=7.8125000000000004e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.331054736818e+02 lambda=3.9062500000000002e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.942479792843e+02 lambda=1.9412500272460620e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.436944624694e+02 lambda=6.4483223307578726e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.292972287211e+02 lambda=6.4483223307578726e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291647778160e+02 lambda=6.4483223307578730e-07 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635261433e+02 lambda=6.4483223307578730e-08 > > Line search: Cubically determined step, current gnorm 1.291635197798e+02 lambda=2.0042115918485846e-08 > > 25 SNES Function norm 1.291635197798e+02 > > 0 KSP Residual norm 1.874745766083e+04 > > 1 KSP Residual norm 1.476978150334e-09 > > Line search: gnorm after quadratic fit 4.089262111368e+11 > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.101717203770e+10 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.352565940292e+09 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.879613196620e+08 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.698613558125e+07 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.175566265039e+07 lambda=3.1250000000000002e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.382919964952e+06 lambda=1.5625000000000001e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.545431975334e+05 lambda=7.8125000000000004e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.713561369103e+04 lambda=3.9062500000000002e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.031789308419e+03 lambda=1.9531250000000001e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.205847020738e+02 lambda=9.7656250000000005e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.957203153158e+02 lambda=2.8132879163728503e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.297923302791e+02 lambda=2.8132879163728504e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291698100579e+02 lambda=2.8132879163728504e-07 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635794525e+02 lambda=2.8132879163728506e-08 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635200489e+02 lambda=2.8132879163728508e-09 > > Line search: Cubically determined step, current gnorm 1.291635197275e+02 lambda=8.0832061492461345e-10 > > 26 SNES Function norm 1.291635197275e+02 > > 0 KSP Residual norm 9.248381077528e+04 > > 1 KSP Residual norm 7.262307068447e-09 > > Line search: gnorm after quadratic fit 4.920647210624e+13 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.153216818065e+12 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.697543960375e+11 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.637004379805e+10 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.208402653149e+10 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.519988135798e+09 lambda=3.1250000000000002e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.923903214787e+08 lambda=1.5625000000000001e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.465663001976e+07 lambda=7.8125000000000004e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.238603967195e+06 lambda=3.9062500000000002e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.459179143177e+05 lambda=1.9531250000000001e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.676301042792e+04 lambda=9.7656250000000005e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.135808875752e+04 lambda=4.8828125000000003e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.275714918657e+03 lambda=2.4414062500000001e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.719037747616e+02 lambda=1.2207031250000001e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.039826156716e+02 lambda=5.5609199181402721e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.308092967809e+02 lambda=9.1057337296683134e-07 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291796742824e+02 lambda=9.1057337296683134e-08 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291636800174e+02 lambda=9.1057337296683134e-09 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635212255e+02 lambda=9.1057337296683134e-10 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635197320e+02 lambda=9.1057337296683139e-11 > > Line search: Cubically determined step, current gnorm 1.291635197254e+02 lambda=3.2898162617097329e-11 > > 27 SNES Function norm 1.291635197254e+02 > > 0 KSP Residual norm 4.818745996826e+05 > > 1 KSP Residual norm 3.300979345194e-08 > > Line search: gnorm after quadratic fit 6.957046028867e+15 > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.695654311477e+14 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.086793500688e+14 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.358083744813e+13 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.696584801696e+12 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.118183549773e+11 lambda=3.1250000000000002e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.641372080976e+10 lambda=1.5625000000000001e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.285878535769e+09 lambda=7.8125000000000004e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.068045470276e+08 lambda=3.9062500000000002e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.988290932539e+07 lambda=1.9531250000000001e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.001404304764e+06 lambda=9.7656250000000005e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.962234585736e+05 lambda=4.8828125000000003e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.648190078115e+04 lambda=2.4414062500000001e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.098288624714e+03 lambda=1.2207031250000001e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.025132922751e+03 lambda=6.1035156250000003e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.536770142392e+02 lambda=3.0517578125000002e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.529553964021e+02 lambda=6.6615844706846272e-07 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.293970371303e+02 lambda=6.6615844706846277e-08 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291658631829e+02 lambda=6.6615844706846284e-09 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635430890e+02 lambda=6.6615844706846284e-10 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635199508e+02 lambda=6.6615844706846284e-11 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635197268e+02 lambda=6.6615844706846284e-12 > > Line search: Cubically determined step, current gnorm 1.291635197253e+02 lambda=1.2496728806533799e-12 > > 28 SNES Function norm 1.291635197253e+02 > > 0 KSP Residual norm 2.124622394867e+06 > > 1 KSP Residual norm 2.766225333896e-07 > > Line search: gnorm after quadratic fit 5.963587884154e+17 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.454611858824e+16 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.318582340500e+15 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.164902175749e+15 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.456326197371e+14 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.820904039469e+13 lambda=3.1250000000000002e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.277371273495e+12 lambda=1.5625000000000001e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.849819609184e+11 lambda=7.8125000000000004e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.570050545145e+10 lambda=3.9062500000000002e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.482064028328e+09 lambda=1.9531250000000001e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.651631635063e+08 lambda=9.7656250000000005e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.188623828904e+07 lambda=4.8828125000000003e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.302868645305e+06 lambda=2.4414062500000001e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.245214424313e+06 lambda=1.2207031250000001e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.775004618570e+05 lambda=6.1035156250000003e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.810228834086e+04 lambda=3.0517578125000002e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.148910945566e+03 lambda=1.5258789062500001e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.133679879416e+03 lambda=7.6293945312500004e-07 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.382468615011e+02 lambda=3.8146972656250002e-07 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.519773483633e+02 lambda=1.4103864371136453e-07 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.293690599792e+02 lambda=1.4103864371136454e-08 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291655645282e+02 lambda=1.4103864371136455e-09 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635401518e+02 lambda=1.4103864371136456e-10 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635199283e+02 lambda=1.4103864371136456e-11 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635197272e+02 lambda=1.4103864371136456e-12 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635197253e+02 lambda=1.4103864371136457e-13 > > Line search: unable to find good step length! After 25 tries > > Line search: fnorm=1.2916351972528861e+02, gnorm=1.2916351972529532e+02, ynorm=2.1246218291095798e+06, minlambda=9.9999999999999998e-13, lambda=1.4103864371136457e-13, initial slope=-1.6683210999382733e+04 > > 0 SNES Function norm 7.158176401507e+03 > > 0 KSP Residual norm 7.545626598553e+02 > > 1 KSP Residual norm 2.192822940623e-11 > > Line search: gnorm after quadratic fit 6.003975664723e+07 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.501930637484e+06 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.380142516806e+05 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.179837352860e+05 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.656902039419e+04 lambda=6.2500000000000003e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.340091686120e+03 lambda=3.1250000000000002e-03 > > Line search: Cubically determined step, current gnorm 7.127478647243e+03 lambda=1.5625000000000001e-03 > > 1 SNES Function norm 7.127478647243e+03 > > 0 KSP Residual norm 3.139792512249e+01 > > 1 KSP Residual norm 5.765552480238e-13 > > Line search: gnorm after quadratic fit 7.131728282938e+03 > > Line search: Cubically determined step, current gnorm 6.730387269330e+03 lambda=5.0000000000000003e-02 > > 2 SNES Function norm 6.730387269330e+03 > > 0 KSP Residual norm 2.247436817553e+01 > > 1 KSP Residual norm 4.129717651221e-13 > > Line search: gnorm after quadratic fit 6.018304311910e+03 > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > 3 SNES Function norm 6.018304311910e+03 > > 0 KSP Residual norm 1.605973421081e+01 > > 1 KSP Residual norm 3.614891198134e-13 > > Line search: gnorm after quadratic fit 5.394599276028e+03 > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > 4 SNES Function norm 5.394599276028e+03 > > 0 KSP Residual norm 1.491002227850e+01 > > 1 KSP Residual norm 5.905756964447e-13 > > Line search: gnorm after quadratic fit 4.845108544722e+03 > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > 5 SNES Function norm 4.845108544722e+03 > > 0 KSP Residual norm 1.562997766581e+02 > > 1 KSP Residual norm 5.722461855805e-12 > > Line search: gnorm after quadratic fit 1.663505509947e+05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.368547472010e+04 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.067825049920e+03 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.852173464442e+03 lambda=1.2500000000000001e-02 > > Line search: Cubically determined step, current gnorm 4.819549937425e+03 lambda=6.2500000000000003e-03 > > 6 SNES Function norm 4.819549937425e+03 > > 0 KSP Residual norm 1.652787385042e+01 > > 1 KSP Residual norm 7.774483442550e-13 > > Line search: gnorm after quadratic fit 2.868840270198e+03 > > Line search: Quadratically determined step, lambda=3.9586658383856743e-01 > > 7 SNES Function norm 2.868840270198e+03 > > 0 KSP Residual norm 1.220061851091e+01 > > 1 KSP Residual norm 4.785407437718e-13 > > Line search: gnorm after quadratic fit 2.616720732407e+03 > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > 8 SNES Function norm 2.616720732407e+03 > > 0 KSP Residual norm 2.884722153958e+01 > > 1 KSP Residual norm 5.474553921306e-13 > > Line search: gnorm after quadratic fit 3.025386805317e+03 > > Line search: Cubically determined step, current gnorm 2.572110173067e+03 lambda=5.0000000000000003e-02 > > 9 SNES Function norm 2.572110173067e+03 > > 0 KSP Residual norm 5.239447686736e+01 > > 1 KSP Residual norm 1.006906008399e-12 > > Line search: gnorm after quadratic fit 5.237562098046e+03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.722529781980e+03 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm 2.553072891461e+03 lambda=2.5000000000000001e-02 > > 10 SNES Function norm 2.553072891461e+03 > > 0 KSP Residual norm 6.511316788880e+00 > > 1 KSP Residual norm 1.340296659008e-13 > > Line search: gnorm after quadratic fit 2.299704119080e+03 > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > 11 SNES Function norm 2.299704119080e+03 > > 0 KSP Residual norm 5.268131426587e+00 > > 1 KSP Residual norm 1.017563310127e-13 > > Line search: Using full step: fnorm 2.299704119080e+03 gnorm 7.642690039388e+02 > > 12 SNES Function norm 7.642690039388e+02 > > 0 KSP Residual norm 1.467735721574e+01 > > 1 KSP Residual norm 1.090242963543e-12 > > Line search: gnorm after quadratic fit 1.042766084830e+03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.924803860137e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm 7.581126971182e+02 lambda=1.8508848315139208e-02 > > 13 SNES Function norm 7.581126971182e+02 > > 0 KSP Residual norm 2.222609581896e+00 > > 1 KSP Residual norm 5.661437314341e-14 > > Line search: gnorm after quadratic fit 6.235337602260e+02 > > Line search: Quadratically determined step, lambda=2.1172883827013136e-01 > > 14 SNES Function norm 6.235337602260e+02 > > 0 KSP Residual norm 3.080209609798e+00 > > 1 KSP Residual norm 6.073476899313e-14 > > Line search: gnorm after quadratic fit 5.704745248520e+02 > > Line search: Quadratically determined step, lambda=1.0142301129466913e-01 > > 15 SNES Function norm 5.704745248520e+02 > > 0 KSP Residual norm 5.628316803979e+00 > > 1 KSP Residual norm 9.930477041779e-14 > > Line search: gnorm after quadratic fit 5.401354794776e+02 > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > 16 SNES Function norm 5.401354794776e+02 > > 0 KSP Residual norm 2.052541406719e+01 > > 1 KSP Residual norm 4.328836834239e-13 > > Line search: gnorm after quadratic fit 1.709850100987e+03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.717966555703e+02 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.414032576976e+02 lambda=8.7805694170804971e-03 > > Line search: Cubically determined step, current gnorm 5.391967144330e+02 lambda=3.6341472475199424e-03 > > 17 SNES Function norm 5.391967144330e+02 > > 0 KSP Residual norm 2.246993769488e+00 > > 1 KSP Residual norm 5.078373642913e-14 > > Line search: gnorm after quadratic fit 4.939618639951e+02 > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > 18 SNES Function norm 4.939618639951e+02 > > 0 KSP Residual norm 2.155867648564e+00 > > 1 KSP Residual norm 4.438622106380e-14 > > Line search: gnorm after quadratic fit 4.334377322188e+02 > > Line search: Quadratically determined step, lambda=1.5092486954829210e-01 > > 19 SNES Function norm 4.334377322188e+02 > > 0 KSP Residual norm 8.318284791610e+00 > > 1 KSP Residual norm 6.910116607023e-13 > > Line search: gnorm after quadratic fit 6.148799641401e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.502386288041e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm 4.297879862602e+02 lambda=1.9565738732695813e-02 > > 20 SNES Function norm 4.297879862602e+02 > > 0 KSP Residual norm 7.593855254976e+01 > > 1 KSP Residual norm 1.300639045149e-12 > > Line search: gnorm after quadratic fit 7.318016560287e+04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.832525429452e+03 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.543595712952e+03 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.752901058720e+02 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.309726315570e+02 lambda=1.2500000000000002e-03 > > Line search: Cubically determined step, current gnorm 4.297464967378e+02 lambda=2.0986409143217158e-04 > > 21 SNES Function norm 4.297464967378e+02 > > 0 KSP Residual norm 8.492609701850e+00 > > 1 KSP Residual norm 2.830329105288e-13 > > Line search: gnorm after quadratic fit 6.575200413213e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.532760802544e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm 4.268212296998e+02 lambda=1.8460064973695799e-02 > > 22 SNES Function norm 4.268212296998e+02 > > 0 KSP Residual norm 2.527155905469e+00 > > 1 KSP Residual norm 2.235724978394e-13 > > Line search: gnorm after quadratic fit 3.958132075117e+02 > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > 23 SNES Function norm 3.958132075117e+02 > > 0 KSP Residual norm 3.425644398425e+00 > > 1 KSP Residual norm 7.166017790799e-14 > > Line search: gnorm after quadratic fit 3.803199338641e+02 > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > 24 SNES Function norm 3.803199338641e+02 > > 0 KSP Residual norm 3.581435186688e+00 > > 1 KSP Residual norm 1.730091027109e-13 > > Line search: gnorm after quadratic fit 3.678433353709e+02 > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > 25 SNES Function norm 3.678433353709e+02 > > 0 KSP Residual norm 2.817439291614e+00 > > 1 KSP Residual norm 8.592333136485e-13 > > Line search: gnorm after quadratic fit 3.472671313564e+02 > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > 26 SNES Function norm 3.472671313564e+02 > > 0 KSP Residual norm 1.830066839089e+00 > > 1 KSP Residual norm 3.248934231575e-14 > > Line search: gnorm after quadratic fit 3.195079998571e+02 > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > 27 SNES Function norm 3.195079998571e+02 > > 0 KSP Residual norm 3.775823654589e+00 > > 1 KSP Residual norm 1.316233059492e-13 > > Line search: gnorm after quadratic fit 3.252874639934e+02 > > Line search: Cubically determined step, current gnorm 3.125168318399e+02 lambda=5.0000000000000003e-02 > > 28 SNES Function norm 3.125168318399e+02 > > 0 KSP Residual norm 3.892613775622e+00 > > 1 KSP Residual norm 7.093200713216e-11 > > Line search: gnorm after quadratic fit 3.137590389484e+02 > > Line search: Cubically determined step, current gnorm 3.045559021319e+02 lambda=5.0000000000000003e-02 > > 29 SNES Function norm 3.045559021319e+02 > > 0 KSP Residual norm 2.364531179390e+00 > > 1 KSP Residual norm 1.615423543115e-12 > > Line search: gnorm after quadratic fit 2.864449141431e+02 > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > 30 SNES Function norm 2.864449141431e+02 > > 0 KSP Residual norm 5.187063704081e+00 > > 1 KSP Residual norm 4.254799504045e-13 > > Line search: gnorm after quadratic fit 3.171238299438e+02 > > Line search: Cubically determined step, current gnorm 2.859321807369e+02 lambda=4.9550691080557742e-02 > > 31 SNES Function norm 2.859321807369e+02 > > 0 KSP Residual norm 2.400449127985e+01 > > 1 KSP Residual norm 5.221032480453e-13 > > Line search: gnorm after quadratic fit 1.812538817802e+03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.647888939229e+02 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.905120335847e+02 lambda=7.3371687404129469e-03 > > Line search: Cubically determined step, current gnorm 2.857698450683e+02 lambda=1.3231746793531958e-03 > > 32 SNES Function norm 2.857698450683e+02 > > 0 KSP Residual norm 7.438521293559e+00 > > 1 KSP Residual norm 1.293652874831e-12 > > Line search: gnorm after quadratic fit 3.600694148787e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.932936811991e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm 2.832774969882e+02 lambda=1.8636088141277370e-02 > > 33 SNES Function norm 2.832774969882e+02 > > 0 KSP Residual norm 2.676138557891e+00 > > 1 KSP Residual norm 5.204105674042e-12 > > Line search: gnorm after quadratic fit 2.698470565576e+02 > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > 34 SNES Function norm 2.698470565576e+02 > > 0 KSP Residual norm 1.009562156863e+01 > > 1 KSP Residual norm 3.544140587695e-13 > > Line search: gnorm after quadratic fit 5.672695948559e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.197216154647e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm 2.694068135292e+02 lambda=1.0762403784106927e-02 > > 35 SNES Function norm 2.694068135292e+02 > > 0 KSP Residual norm 3.927549314525e+00 > > 1 KSP Residual norm 2.619134786598e-13 > > Line search: gnorm after quadratic fit 2.646675787349e+02 > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > 36 SNES Function norm 2.646675787349e+02 > > 0 KSP Residual norm 3.630219417922e+01 > > 1 KSP Residual norm 1.546302717349e-12 > > Line search: gnorm after quadratic fit 1.827432666108e+04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.342968941151e+03 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.008633273369e+02 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.490753494196e+02 lambda=1.2345129233072847e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.682474011960e+02 lambda=3.3291959087019770e-03 > > Line search: Cubically determined step, current gnorm 2.646227701989e+02 lambda=4.0529212866107715e-04 > > 37 SNES Function norm 2.646227701989e+02 > > 0 KSP Residual norm 8.122774697994e+00 > > 1 KSP Residual norm 1.316362046092e-13 > > Line search: gnorm after quadratic fit 4.731092571363e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.030088374328e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm 2.637462652877e+02 lambda=9.1057248517509397e-03 > > 38 SNES Function norm 2.637462652877e+02 > > 0 KSP Residual norm 2.601520363063e+00 > > 1 KSP Residual norm 1.060764270007e-12 > > Line search: gnorm after quadratic fit 2.536856446094e+02 > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > 39 SNES Function norm 2.536856446094e+02 > > 0 KSP Residual norm 5.447955134327e+01 > > 1 KSP Residual norm 2.556989975730e-12 > > Line search: gnorm after quadratic fit 9.199250935618e+03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.998238940105e+03 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.227083769291e+02 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.852215674478e+02 lambda=8.5024965111563117e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.537821339347e+02 lambda=8.5024965111563122e-04 > > Line search: Cubically determined step, current gnorm 2.536484146652e+02 lambda=2.9594242443314720e-04 > > 40 SNES Function norm 2.536484146652e+02 > > 0 KSP Residual norm 3.357359266965e+01 > > 1 KSP Residual norm 8.485166742752e-11 > > Line search: gnorm after quadratic fit 3.327150899857e+03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.660943990394e+02 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.428891921377e+02 lambda=2.2262238648584176e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.550059920785e+02 lambda=3.9120439672600755e-03 > > Line search: Cubically determined step, current gnorm 2.535425543202e+02 lambda=8.8078244093807846e-04 > > 41 SNES Function norm 2.535425543202e+02 > > 0 KSP Residual norm 1.982789391732e+01 > > 1 KSP Residual norm 1.156473750758e-11 > > Line search: gnorm after quadratic fit 9.648483369708e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.023504841042e+02 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.554919970151e+02 lambda=8.7092873850291869e-03 > > Line search: Cubically determined step, current gnorm 2.532490636747e+02 lambda=2.4564558988847251e-03 > > 42 SNES Function norm 2.532490636747e+02 > > 0 KSP Residual norm 1.762994613361e+01 > > 1 KSP Residual norm 4.550684860593e-12 > > Line search: gnorm after quadratic fit 6.772107527838e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.370541870778e+02 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.532869639177e+02 lambda=7.7662700854918328e-03 > > Line search: Cubically determined step, current gnorm 2.527651129995e+02 lambda=3.8686733161537824e-03 > > 43 SNES Function norm 2.527651129995e+02 > > 0 KSP Residual norm 1.559278923951e+01 > > 1 KSP Residual norm 1.060470887103e-11 > > Line search: gnorm after quadratic fit 7.344361373020e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.498001534426e+02 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.530518382567e+02 lambda=7.6730113050967469e-03 > > Line search: Cubically determined step, current gnorm 2.523423548732e+02 lambda=3.4156098513217236e-03 > > 44 SNES Function norm 2.523423548732e+02 > > 0 KSP Residual norm 1.190500639095e+01 > > 1 KSP Residual norm 6.311739265577e-12 > > Line search: gnorm after quadratic fit 4.875196633557e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.933215922947e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm 2.516782376717e+02 lambda=9.8878729665301743e-03 > > 45 SNES Function norm 2.516782376717e+02 > > 0 KSP Residual norm 1.003632001309e+01 > > 1 KSP Residual norm 7.039473047666e-13 > > Line search: gnorm after quadratic fit 3.417133560813e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.636443273929e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm 2.499729768042e+02 lambda=1.5332495922160540e-02 > > 46 SNES Function norm 2.499729768042e+02 > > 0 KSP Residual norm 5.252587112411e+01 > > 1 KSP Residual norm 2.072629114336e-12 > > Line search: gnorm after quadratic fit 7.891803681498e+03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.819076698717e+03 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.911876424956e+02 lambda=2.4538865368827514e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.688195882303e+02 lambda=6.5764457912135515e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.500076295129e+02 lambda=6.5764457912135523e-04 > > Line search: Cubically determined step, current gnorm 2.499390700783e+02 lambda=2.7231956365922875e-04 > > 47 SNES Function norm 2.499390700783e+02 > > 0 KSP Residual norm 4.007648116930e+01 > > 1 KSP Residual norm 5.646654234336e-11 > > Line search: gnorm after quadratic fit 6.276152857499e+03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.418274035925e+03 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.785345842563e+02 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.665412152699e+02 lambda=8.0607289886479045e-03 > > Line search: Cubically determined step, current gnorm 2.499109739904e+02 lambda=8.0607289886479045e-04 > > 48 SNES Function norm 2.499109739904e+02 > > 0 KSP Residual norm 1.339756751889e+01 > > 1 KSP Residual norm 2.559175980945e-13 > > Line search: gnorm after quadratic fit 6.052259901869e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.217431518450e+02 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm 2.496541765916e+02 lambda=7.0239599632283649e-03 > > 49 SNES Function norm 2.496541765916e+02 > > 0 KSP Residual norm 5.340771873687e+00 > > 1 KSP Residual norm 1.207454778077e-13 > > Line search: gnorm after quadratic fit 2.760767095070e+02 > > Line search: Cubically determined step, current gnorm 2.491630276458e+02 lambda=5.0000000000000003e-02 > > 50 SNES Function norm 2.491630276458e+02 > > > > > > On Sat, Aug 26, 2017 at 11:45 PM, Barry Smith wrote: > > > > > On Aug 26, 2017, at 10:43 PM, zakaryah . wrote: > > > > > > Hi Barry - many thanks for taking the time to understand my many problems and providing so much help. > > > > > > The reason I was concerned that I could not alter the linesearch was when I tried to use bt instead of the L-BFGS default, cp, the code crashed with an error like "Could not get Jacobian". Maybe this is an incompatibility like you say, since L-BFGS only uses the initial Jacobian and I never tried setting the scale type. > > > > > > I took your advice and tried to shrink the problem. First I tried shrinking by a factor 1000 but this converged very quickly with all test data I could provide, including the data which was problematic with the large grid. So I settled for a reduction in size by a factor 125. The grid size is 13,230. This is a decent test case because the solver fails to converge with the options I was using before, and it is small enough that I can run it with the options you suggested (-snes_fd_color -snes_type newtonls -snes_monitor -snes_linesearch_monitor -ksp_monitor -pc_type lu). > > > > > > The output is 1800 lines long - how shall I share it? > > > > Just email it, that is small enough for email. > > > > Barry > > > > > > > > > > > > > > > > > On Sat, Aug 26, 2017 at 7:38 PM, Barry Smith wrote: > > > > > > > On Aug 26, 2017, at 5:56 PM, zakaryah . wrote: > > > > > > > > I'm using PETSc's SNES methods to solve PDEs which result from Euler-Lagrange equations for the strain energy of a 3D displacement field. There is an additional term in the Lagrangian which describes external forces which arise from various data sets, and that term contains nonlinearities (field terms higher than linear). The grid has about 1.6e6 elements, and the displacement field has 3 components at each grid element. > > > > > > > > I'm trying to solve a sequence of successively more complicated equations, and the latest equation is failing to converge on some data sets. In particular, the methods were successful for the infinitesimal bulk strain (compression) energy, as well as the full infinitesimal strain energy (bulk + shear), but I'm now trying to generalize to the finite strain, as certain data sets are known to result from displacement fields for which the infinitesimal strain is a poor approximation. > > > > > > > > I'm using a DMDA, closely following example 48, and my preferred solver is L-BFGS. > > > > > > So you are using ? > > > > > > -snes_type qn -snes_qn_type lbfgs > > > > > > > > > > > I have read the FAQs "Why is Newton's method not converging??" and "Why is my iterative linear solver not converging??"? which have raised a number of questions: > > > > > > Quasi Newton methods either don't use Jacobians or use only the initial Jacobian (the idea behind quasi-Newton methods is to approximate Jacobian information from previous iterations without having the user compute a Jacobian at each iteration). With PETSc's qn it only uses the Jacobian if you use the option > > > > > > -snes_qn_scale_type Jacobian > > > > > > otherwise the Jacobian is never computed or used > > > > > > > > > > > > > > Is there documentation for the DMDA/SNES methods somewhere? I don't understand these very well. For example, I am not allocating any matrix for the global Jacobian, and I believe this prevents me from changing the line search. If I'm mistaken I would love to see an example of changing the line search type while using DMDA/SNES. > > > > > > Whether you provide a Jacobian or not is orthogonal to the line search. > > > > > > You should be able to change the line search with > > > > > > -snes_linesearch_type bt or nleqerr or basic or l2 or cp > > > > > > not all of them may work with qn > > > > > > > > > > > > > > I don't know how to interpret the linesearch monitor. Even for problems which are converging properly, the linesearch monitor reports "lssucceed=0" on every iteration. Is this a problem? > > > > > > It returns a 0 if the line search does not believe it has achieved "sufficient decrease" in the function norm (or possibly some other measure of decrease) you should run -snes_linesearch_monitor also with the option -snes_monitor to see what is happening to the function norm > > > > > > For qn you can add the option > > > > > > -snes_qn_monitor > > > > > > to get more detailed monitoring > > > > > > > > > > > > > > I'm also having trouble understanding the methods for troubleshooting. I suspect that I've made an error in the analytical Jacobian, which has a rather large number of non-zero elements, but I have no idea how to use -snes_type test -snes_test_display. The FAQs mention that some troubleshooting tools are more useful for small test problems. How small is small? > > > > > > Tiny, at most a few dozen rows and columns in the Jacobin. > > > > > > You should run without the -snes_test_display information, what does it say? Does it indicate the Jacobian or report there is likely a problem? > > > > > > With DMDA you can also use -snes_fd_color to have PETSc compute the Jacobian for you instead of using your analytical form. If it works with this, but not your Jacobian then your Jacobian is wrong. > > > > > > > When I try to run the program with -snes_type test -snes_test_display, I get errors like: > > > > > > > > [0]PETSC ERROR: Argument out of range [0]PETSC ERROR: Local index 1076396032 too large 4979879 (max) at 0 > > > > > > > > The second size is 1 less than the number of field elements, while the first number seems too large for any aspect of the problem - the Jacobian has at most 59 non-zero columns per row. > > > > > > > > Because I suspect a possible error in the Jacobian, I ran with -snes_mf_operator -pc_type ksp -ksp_ksp_rtol 1e-12 and observed very similar failure to converge (diverging residual) as with the explicit Jacobian. > > > > > > What do you get with -ksp_monitor -ksp_ksp_monitor it sounds like the true Jacobian is either very ill-conditioned or your function evaluation is wrong. > > > > > > > Do I need to set an SNES method which is somehow compatible with the "matrix-free" approach? If I instead use -snes_mf, the problem seems to converge, but horrendously slowly (true residual relative decrease by about 1e-5 per iteration). I suppose this supports my suspicion that the Jacobian is incorrect but doesn't really suggest a solution. > > > > > > > > Is it possible that the analytical Jacobian is correct, but somehow pathological, which causes the SNES to diverge? > > > > > > Yes > > > > > > > Neither the Jacobian nor the function have singularities. > > > > > > > > Thanks for any help you can provide! > > > > > > Try really hard to set up a small problem (like just use a very coarse grid) to experiment with as you try to get convergence. Using a big problem for debugging convergence is a recipe for pain. > > > > > > Also since you have a Jacobian I would start with -snes_fd_color -snes_type ls -snes_monitor -snes_linesearch_monitor -ksp_monitor -pc_type lu (not on a huge problem), what happens? Send the output > > > > > > Barry > > > > > > > > > > > > > > > From zakaryah at gmail.com Sat Aug 26 23:14:39 2017 From: zakaryah at gmail.com (zakaryah .) Date: Sun, 27 Aug 2017 00:14:39 -0400 Subject: [petsc-users] A number of questions about DMDA with SNES and Quasi-Newton methods In-Reply-To: References: <020DAED9-AAAD-4741-976B-BB2EF6C79D3F@mcs.anl.gov> <5BF530F6-8D79-47E6-B2C5-B0702FF2AA59@mcs.anl.gov> <7EE84495-4346-4BFB-B9AD-BCAA3C722461@mcs.anl.gov> Message-ID: Sure - it was this: mpiexec -n 1 -snes_fd_color -snes_type newtonls -snes_monitor -snes_linesearch_monitor -ksp_monitor -pc_type lu On Sun, Aug 27, 2017 at 12:11 AM, Barry Smith wrote: > > > On Aug 26, 2017, at 10:55 PM, zakaryah . wrote: > > > > Yes, except I changed "-snes_type ls" to "-snes_type newtonls" because > PETSc complained that ls wasn't a known method. > > Sorry, my memory is not as good as it used to be; but what other options > did you use? Send the exact command line. > > > Barry > ' > > > > On Sat, Aug 26, 2017 at 11:52 PM, Barry Smith > wrote: > > > > My exact options did you run with? > > > > > On Aug 26, 2017, at 10:48 PM, zakaryah . wrote: > > > > > > Here's the output, from the data set which does not converge with > l-bfgs: > > > > > > 0 SNES Function norm 1.370293318432e+04 > > > 0 KSP Residual norm 7.457506389218e+02 > > > 1 KSP Residual norm 2.244764079994e-10 > > > Line search: gnorm after quadratic fit 6.541298279196e+05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 8.963717927372e+04 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.788909416707e+04 lambda=2.5000000000000001e-02 > > > Line search: Cubically determined step, current gnorm > 1.340565762719e+04 lambda=1.2500000000000001e-02 > > > 1 SNES Function norm 1.340565762719e+04 > > > 0 KSP Residual norm 4.096066553372e+02 > > > 1 KSP Residual norm 3.313671167444e-11 > > > Line search: gnorm after quadratic fit 1.113749573695e+06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.406390140546e+05 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.126781917443e+04 lambda=2.5000000000000001e-02 > > > Line search: Cubically determined step, current gnorm > 1.272988597973e+04 lambda=1.2500000000000001e-02 > > > 2 SNES Function norm 1.272988597973e+04 > > > 0 KSP Residual norm 8.291344597817e+01 > > > 1 KSP Residual norm 7.182258362182e-12 > > > Line search: gnorm after quadratic fit 1.121913743889e+04 > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > 3 SNES Function norm 1.121913743889e+04 > > > 0 KSP Residual norm 6.830535877014e+01 > > > 1 KSP Residual norm 3.629826411580e-12 > > > Line search: gnorm after quadratic fit 9.966344973786e+03 > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > 4 SNES Function norm 9.966344973786e+03 > > > 0 KSP Residual norm 5.137691531345e+01 > > > 1 KSP Residual norm 1.954502098181e-12 > > > Line search: gnorm after quadratic fit 8.905508641232e+03 > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > 5 SNES Function norm 8.905508641232e+03 > > > 0 KSP Residual norm 4.295019262963e+01 > > > 1 KSP Residual norm 1.581527994925e-12 > > > Line search: gnorm after quadratic fit 7.599173694189e+03 > > > Line search: Quadratically determined step, > lambda=1.4157226463489950e-01 > > > 6 SNES Function norm 7.599173694189e+03 > > > 0 KSP Residual norm 3.520472291520e+01 > > > 1 KSP Residual norm 1.169994130568e-12 > > > Line search: gnorm after quadratic fit 6.797214843928e+03 > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > 7 SNES Function norm 6.797214843928e+03 > > > 0 KSP Residual norm 2.683523206056e+01 > > > 1 KSP Residual norm 9.039858014119e-13 > > > Line search: gnorm after quadratic fit 6.098038917364e+03 > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > 8 SNES Function norm 6.098038917364e+03 > > > 0 KSP Residual norm 2.300710560681e+01 > > > 1 KSP Residual norm 1.010402303464e-12 > > > Line search: gnorm after quadratic fit 5.486151385552e+03 > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > 9 SNES Function norm 5.486151385552e+03 > > > 0 KSP Residual norm 2.824628827619e+01 > > > 1 KSP Residual norm 1.009589866569e-12 > > > Line search: gnorm after quadratic fit 4.964991021247e+03 > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > 10 SNES Function norm 4.964991021247e+03 > > > 0 KSP Residual norm 6.285926028595e+01 > > > 1 KSP Residual norm 2.833546214180e-12 > > > Line search: gnorm after quadratic fit 2.100041391472e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.804051080767e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm > 4.893296169579e+03 lambda=2.5000000000000001e-02 > > > 11 SNES Function norm 4.893296169579e+03 > > > 0 KSP Residual norm 1.688978282804e+01 > > > 1 KSP Residual norm 5.927677470786e-13 > > > Line search: gnorm after quadratic fit 4.400894622431e+03 > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > 12 SNES Function norm 4.400894622431e+03 > > > 0 KSP Residual norm 1.481197699600e+01 > > > 1 KSP Residual norm 4.522572128105e-13 > > > Line search: Using full step: fnorm 4.400894622431e+03 gnorm > 2.094971849007e+03 > > > 13 SNES Function norm 2.094971849007e+03 > > > 0 KSP Residual norm 3.514164563318e+00 > > > 1 KSP Residual norm 3.022385947499e-13 > > > Line search: gnorm after quadratic fit 1.687641025382e+03 > > > Line search: Quadratically determined step, > lambda=2.0307116693368590e-01 > > > 14 SNES Function norm 1.687641025382e+03 > > > 0 KSP Residual norm 2.138591884686e+00 > > > 1 KSP Residual norm 4.023500814078e-14 > > > Line search: Using full step: fnorm 1.687641025382e+03 gnorm > 1.131934218470e+03 > > > 15 SNES Function norm 1.131934218470e+03 > > > 0 KSP Residual norm 3.245035110327e+00 > > > 1 KSP Residual norm 1.293626215269e-13 > > > Line search: Using full step: fnorm 1.131934218470e+03 gnorm > 7.340573607307e+02 > > > 16 SNES Function norm 7.340573607307e+02 > > > 0 KSP Residual norm 1.957698957904e+00 > > > 1 KSP Residual norm 3.444648967078e-13 > > > Line search: Using full step: fnorm 7.340573607307e+02 gnorm > 5.024723505168e+02 > > > 17 SNES Function norm 5.024723505168e+02 > > > 0 KSP Residual norm 2.510538703839e+00 > > > 1 KSP Residual norm 8.570440675253e-14 > > > Line search: gnorm after quadratic fit 4.548776456608e+02 > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > 18 SNES Function norm 4.548776456608e+02 > > > 0 KSP Residual norm 6.741705718178e-01 > > > 1 KSP Residual norm 1.650556120809e-14 > > > Line search: Using full step: fnorm 4.548776456608e+02 gnorm > 1.351189086642e+02 > > > 19 SNES Function norm 1.351189086642e+02 > > > 0 KSP Residual norm 7.653741241950e+00 > > > 1 KSP Residual norm 8.326848236950e-14 > > > Line search: gnorm after quadratic fit 4.215455105006e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.889750369356e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.358691836999e+02 lambda=1.0303015930243279e-02 > > > Line search: Cubically determined step, current gnorm > 1.348911963390e+02 lambda=3.5279526770504110e-03 > > > 20 SNES Function norm 1.348911963390e+02 > > > 0 KSP Residual norm 4.209281176918e+00 > > > 1 KSP Residual norm 1.233232881375e-13 > > > Line search: gnorm after quadratic fit 1.860023264470e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.413911132196e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm > 1.339597869053e+02 lambda=1.5787957598629023e-02 > > > 21 SNES Function norm 1.339597869053e+02 > > > 0 KSP Residual norm 1.718484765841e+00 > > > 1 KSP Residual norm 6.666016296543e-14 > > > Line search: gnorm after quadratic fit 1.326878521472e+02 > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > 22 SNES Function norm 1.326878521472e+02 > > > 0 KSP Residual norm 1.515373499919e+00 > > > 1 KSP Residual norm 2.259154130795e-12 > > > Line search: gnorm after quadratic fit 1.226907316391e+02 > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > 23 SNES Function norm 1.226907316391e+02 > > > 0 KSP Residual norm 1.080252936903e+00 > > > 1 KSP Residual norm 1.847020526683e-14 > > > Line search: gnorm after quadratic fit 1.163632111851e+02 > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > 24 SNES Function norm 1.163632111851e+02 > > > 0 KSP Residual norm 2.491746958382e+00 > > > 1 KSP Residual norm 6.389134193637e-14 > > > Line search: gnorm after quadratic fit 1.345487153563e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.169738363622e+02 lambda=4.4108900954515480e-02 > > > Line search: Cubically determined step, current gnorm > 1.152177638108e+02 lambda=1.9997442889243631e-02 > > > 25 SNES Function norm 1.152177638108e+02 > > > 0 KSP Residual norm 5.364385501004e+00 > > > 1 KSP Residual norm 8.457149562463e-14 > > > Line search: gnorm after quadratic fit 2.722095758964e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.480946353374e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm > 1.150680255994e+02 lambda=6.3560128131639167e-03 > > > 26 SNES Function norm 1.150680255994e+02 > > > 0 KSP Residual norm 4.302025268263e+00 > > > 1 KSP Residual norm 1.017526937941e-13 > > > Line search: gnorm after quadratic fit 1.956300983573e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.318600522939e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm > 1.147123505014e+02 lambda=7.6060788653548803e-03 > > > 27 SNES Function norm 1.147123505014e+02 > > > 0 KSP Residual norm 6.195463111324e+00 > > > 1 KSP Residual norm 1.235283250361e-13 > > > Line search: gnorm after quadratic fit 3.324821547049e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.612593208504e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.147389525772e+02 lambda=6.1750939181374294e-03 > > > Line search: Cubically determined step, current gnorm > 1.145411432123e+02 lambda=3.0078592586792975e-03 > > > 28 SNES Function norm 1.145411432123e+02 > > > 0 KSP Residual norm 1.454704250187e+01 > > > 1 KSP Residual norm 2.368485174123e-13 > > > Line search: gnorm after quadratic fit 1.216293873116e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.796524621727e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.359314163651e+02 lambda=1.4867675803955788e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.146009802557e+02 lambda=1.4867675803955788e-03 > > > Line search: Cubically determined step, current gnorm > 1.145096815033e+02 lambda=5.5250912472932839e-04 > > > 29 SNES Function norm 1.145096815033e+02 > > > 0 KSP Residual norm 3.430451345093e+01 > > > 1 KSP Residual norm 1.069396165938e-12 > > > Line search: gnorm after quadratic fit 1.161329407098e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.260690718050e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.696806489042e+02 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.960149915648e+02 lambda=1.1276129246469476e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.158113641658e+02 lambda=1.5873910451430554e-03 > > > Line search: Cubically determined step, current gnorm > 1.145062232916e+02 lambda=1.5873910451430555e-04 > > > 30 SNES Function norm 1.145062232916e+02 > > > 0 KSP Residual norm 2.662578971526e+01 > > > 1 KSP Residual norm 5.464011789728e-13 > > > Line search: gnorm after quadratic fit 4.375119254490e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.038018103928e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.169328002874e+02 lambda=2.3789161387159519e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.262835432714e+02 lambda=5.9737415571960795e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.145626045197e+02 lambda=5.9737415571960802e-04 > > > Line search: Cubically determined step, current gnorm > 1.144968604079e+02 lambda=1.6421773527706333e-04 > > > 31 SNES Function norm 1.144968604079e+02 > > > 0 KSP Residual norm 6.322033697338e+01 > > > 1 KSP Residual norm 1.507157991448e-12 > > > Line search: gnorm after quadratic fit 5.809243699277e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 9.460487584142e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.893183483197e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.960337007072e+02 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.771527792790e+02 lambda=5.3912931685137378e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.150137639707e+02 lambda=5.3912931685137376e-04 > > > Line search: Cubically determined step, current gnorm > 1.144964484571e+02 lambda=5.3912931685137380e-05 > > > 32 SNES Function norm 1.144964484571e+02 > > > 0 KSP Residual norm 3.859510930996e+01 > > > 1 KSP Residual norm 8.069118044382e-13 > > > Line search: gnorm after quadratic fit 1.106329930525e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.155884463041e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.933963819094e+02 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.849629797377e+02 lambda=9.7744286136270241e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.150857687050e+02 lambda=9.7744286136270254e-04 > > > Line search: Cubically determined step, current gnorm > 1.144922906340e+02 lambda=9.7744286136270254e-05 > > > 33 SNES Function norm 1.144922906340e+02 > > > 0 KSP Residual norm 4.952038022394e+01 > > > 1 KSP Residual norm 7.460263245424e-13 > > > Line search: gnorm after quadratic fit 3.005091127220e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.229308416025e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.138600794682e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.390856262238e+02 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.394997214983e+02 lambda=4.4582997750629580e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.146836358799e+02 lambda=4.4582997750629581e-04 > > > Line search: Cubically determined step, current gnorm > 1.144895966587e+02 lambda=4.7644082443915877e-05 > > > 34 SNES Function norm 1.144895966587e+02 > > > 0 KSP Residual norm 1.146914786457e+02 > > > 1 KSP Residual norm 4.791627042400e-12 > > > Line search: gnorm after quadratic fit 2.601294145944e+05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.324148513778e+04 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.247478406023e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.200340900661e+03 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.696223112300e+02 lambda=6.1514413845115794e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.342365431983e+02 lambda=1.7502929694284564e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.146686063035e+02 lambda=1.7502929694284566e-04 > > > Line search: Cubically determined step, current gnorm > 1.144895868489e+02 lambda=1.7502929694284566e-05 > > > 35 SNES Function norm 1.144895868489e+02 > > > 0 KSP Residual norm 6.311017209658e+01 > > > 1 KSP Residual norm 8.384445939117e-13 > > > Line search: gnorm after quadratic fit 5.781533400572e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 9.419557746031e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.886081770030e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.945810143740e+02 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.767820854837e+02 lambda=5.3859001959289735e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.150034040559e+02 lambda=5.3859001959289732e-04 > > > Line search: Cubically determined step, current gnorm > 1.144891501665e+02 lambda=5.3859001959289732e-05 > > > 36 SNES Function norm 1.144891501665e+02 > > > 0 KSP Residual norm 3.880748384332e+01 > > > 1 KSP Residual norm 6.400339290453e-13 > > > Line search: gnorm after quadratic fit 1.122504184426e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.180728237366e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.987870621566e+02 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.863711604331e+02 lambda=9.8150771384688824e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.150916783781e+02 lambda=9.8150771384688824e-04 > > > Line search: Cubically determined step, current gnorm > 1.144850837411e+02 lambda=9.8150771384688832e-05 > > > 37 SNES Function norm 1.144850837411e+02 > > > 0 KSP Residual norm 4.811537498557e+01 > > > 1 KSP Residual norm 9.738167670242e-13 > > > Line search: gnorm after quadratic fit 2.784098355218e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.885118868254e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.074843354348e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.255202820836e+02 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.365202996130e+02 lambda=4.3204204582016374e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.146504919412e+02 lambda=4.3204204582016374e-04 > > > Line search: Cubically determined step, current gnorm > 1.144822306241e+02 lambda=5.0376546850227848e-05 > > > 38 SNES Function norm 1.144822306241e+02 > > > 0 KSP Residual norm 1.120914002482e+02 > > > 1 KSP Residual norm 5.452125292284e-12 > > > Line search: gnorm after quadratic fit 2.427186680567e+05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.112196656857e+04 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.967397366072e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.149551659770e+03 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.529630886791e+02 lambda=6.0885216927030559e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.315267519231e+02 lambda=1.6656233536183130e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.146353659250e+02 lambda=1.6656233536183130e-04 > > > Line search: Cubically determined step, current gnorm > 1.144820487391e+02 lambda=1.6656233536183130e-05 > > > 39 SNES Function norm 1.144820487391e+02 > > > 0 KSP Residual norm 7.182416170980e+01 > > > 1 KSP Residual norm 1.292147133333e-12 > > > Line search: gnorm after quadratic fit 8.255331293322e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.302939895170e+04 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.501228089911e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.185010378583e+02 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.088179821424e+02 lambda=5.7489510178867142e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.168272901121e+02 lambda=9.7452649444612811e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.144951972300e+02 lambda=9.7452649444612822e-05 > > > Line search: Cubically determined step, current gnorm > 1.144807676687e+02 lambda=2.2399506502463798e-05 > > > 40 SNES Function norm 1.144807676687e+02 > > > 0 KSP Residual norm 1.728679810285e+02 > > > 1 KSP Residual norm 3.878068639716e-12 > > > Line search: gnorm after quadratic fit 9.011020578535e+05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.111818830011e+05 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.504789858103e+04 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.754312133162e+03 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.212492111975e+02 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.199969180537e+02 lambda=2.6424184504193135e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.154794639440e+02 lambda=2.6424184504193136e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.144880673342e+02 lambda=2.6424184504193136e-05 > > > Line search: Cubically determined step, current gnorm > 1.144805461570e+02 lambda=3.8712107591125690e-06 > > > 41 SNES Function norm 1.144805461570e+02 > > > 0 KSP Residual norm 4.162780846202e+02 > > > 1 KSP Residual norm 1.732341544934e-11 > > > Line search: gnorm after quadratic fit 1.355673864369e+07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.747523002884e+06 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.342205048417e+05 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.425635699680e+04 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.882150659178e+03 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.259664786336e+03 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.653670676209e+02 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.453655830144e+02 lambda=5.8237455565260388e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.147659525018e+02 lambda=5.8237455565260393e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.144827915995e+02 lambda=5.8237455565260400e-06 > > > Line search: Cubically determined step, current gnorm > 1.144805080017e+02 lambda=6.6689295146509104e-07 > > > 42 SNES Function norm 1.144805080017e+02 > > > 0 KSP Residual norm 1.004135512581e+03 > > > 1 KSP Residual norm 3.867626041000e-09 > > > Line search: gnorm after quadratic fit 1.832578994882e+08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.269698278878e+07 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.792476589915e+06 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.420660371083e+05 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.321686926168e+04 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.548358078234e+03 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.429504802276e+03 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.317723385004e+02 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.460079723095e+02 lambda=2.5078917343692407e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.147908977725e+02 lambda=2.5078917343692408e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.144833604238e+02 lambda=2.5078917343692412e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.144805106824e+02 lambda=2.5078917343692411e-07 > > > Line search: Cubically determined step, current gnorm > 1.144805014337e+02 lambda=1.1468707119027746e-07 > > > 43 SNES Function norm 1.144805014337e+02 > > > 0 KSP Residual norm 2.418614573592e+03 > > > 1 KSP Residual norm 6.085078742847e-10 > > > Line search: gnorm after quadratic fit 2.598476259775e+09 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.262759415873e+08 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.116845970403e+07 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.250465130250e+06 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.863493884574e+05 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 9.501468163771e+04 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.482658980483e+04 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.802395557883e+03 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.788149582374e+02 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.248828337038e+02 lambda=1.8333058767960295e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.186285836222e+02 lambda=3.7550993478654105e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.145209710139e+02 lambda=3.7550993478654107e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.144808670668e+02 lambda=3.7550993478654111e-07 > > > Line search: Cubically determined step, current gnorm > 1.144805012252e+02 lambda=3.7550993478654114e-08 > > > 44 SNES Function norm 1.144805012252e+02 > > > 0 KSP Residual norm 1.432476672735e+03 > > > 1 KSP Residual norm 7.850524783892e-11 > > > Line search: gnorm after quadratic fit 5.336191593632e+08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.625576866625e+07 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 8.181408387845e+06 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.003310644422e+06 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.236384273292e+05 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.658430638069e+04 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.977463068161e+03 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.674238499253e+02 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.333616820791e+02 lambda=3.3764776729281175e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.161349153752e+02 lambda=4.0497161764116874e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.144966925969e+02 lambda=4.0497161764116874e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.144806214839e+02 lambda=4.0497161764116878e-07 > > > Line search: Cubically determined step, current gnorm > 1.144804979966e+02 lambda=5.6339112427782378e-08 > > > 45 SNES Function norm 1.144804979966e+02 > > > 0 KSP Residual norm 3.453401579761e+03 > > > 1 KSP Residual norm 4.197968028126e-09 > > > Line search: gnorm after quadratic fit 7.554006183767e+09 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 9.471974940372e+08 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.191613865049e+08 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.509784334249e+07 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.943752478560e+06 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.597601716755e+05 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.775572331075e+04 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.418045407608e+03 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.357066758731e+03 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.859267839080e+02 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.501494912160e+02 lambda=7.5160826909319168e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.148144926477e+02 lambda=7.5160826909319171e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.144837498478e+02 lambda=7.5160826909319179e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.144805227746e+02 lambda=7.5160826909319182e-08 > > > Line search: Cubically determined step, current gnorm > 1.144804974438e+02 lambda=9.6864021663644795e-09 > > > 46 SNES Function norm 1.144804974438e+02 > > > 0 KSP Residual norm 8.345139428850e+03 > > > 1 KSP Residual norm 1.027819754739e-09 > > > Line search: gnorm after quadratic fit 1.061319903906e+11 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.325012985379e+10 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.652236226640e+09 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.055533971630e+08 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.546607716763e+07 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.134442858835e+06 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.839168570687e+05 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.830568178626e+04 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.201776786081e+03 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.540520468013e+03 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.573504890506e+02 lambda=9.7656250000000005e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.516203908013e+02 lambda=3.2703670177372021e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.148480075676e+02 lambda=3.2703670177372022e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.144841475328e+02 lambda=3.2703670177372023e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.144805305720e+02 lambda=3.2703670177372021e-08 > > > Line search: Cubically determined step, current gnorm > 1.144804974367e+02 lambda=3.2703670177372025e-09 > > > 47 SNES Function norm 1.144804974367e+02 > > > 0 KSP Residual norm 4.668983500382e+03 > > > 1 KSP Residual norm 1.398997665317e-09 > > > Line search: gnorm after quadratic fit 1.865309565532e+10 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.336975299727e+09 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.934905088739e+08 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.704520478641e+07 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.728477809448e+06 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.193001670096e+05 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 8.610673238239e+04 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.354711683605e+04 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.589557246433e+03 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.367851970709e+02 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.136930269795e+02 lambda=9.0316845802227864e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.172186635069e+02 lambda=1.5831613287181393e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.145074017254e+02 lambda=1.5831613287181394e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.144807499816e+02 lambda=1.5831613287181396e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.144804983345e+02 lambda=1.5831613287181397e-08 > > > Line search: Cubically determined step, current gnorm > 1.144804971346e+02 lambda=5.2932921109871310e-09 > > > 48 SNES Function norm 1.144804971346e+02 > > > 0 KSP Residual norm 1.132678078317e+04 > > > 1 KSP Residual norm 2.477518733314e-10 > > > Line search: gnorm after quadratic fit 2.654659022365e+11 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.315296223725e+10 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.136635677074e+09 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.152507060235e+08 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.397060094478e+07 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.898362012287e+06 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 9.685179520906e+05 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.194040779842e+05 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.606415730227e+04 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.902698091972e+03 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.521549384652e+02 lambda=9.7656250000000005e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.288999778994e+02 lambda=4.1899746703195281e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.157880829786e+02 lambda=4.5470218451893824e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.144935741206e+02 lambda=4.5470218451893828e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.144806232638e+02 lambda=4.5470218451893831e-08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.144804979250e+02 lambda=4.5470218451893835e-09 > > > Line search: Cubically determined step, current gnorm > 1.144804970825e+02 lambda=9.0293679903918216e-10 > > > 49 SNES Function norm 1.144804970825e+02 > > > 0 KSP Residual norm 2.712544829144e+04 > > > 1 KSP Residual norm 4.949246309677e-09 > > > Line search: gnorm after quadratic fit 3.650846005745e+12 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.565321055911e+11 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.711080201118e+10 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.150022242308e+09 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 8.965954117985e+08 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.128096393645e+08 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.429702091584e+07 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.841819946536e+06 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.465032956946e+05 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.594210253794e+04 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.141110278944e+03 lambda=9.7656250000000005e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.306952279045e+03 lambda=4.8828125000000003e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.754164864338e+02 lambda=2.4414062500000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.476861367158e+02 lambda=9.2451761406722810e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.147929263780e+02 lambda=9.2451761406722810e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.144836022952e+02 lambda=9.2451761406722821e-08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.144805271860e+02 lambda=9.2451761406722831e-09 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.144804972895e+02 lambda=9.2451761406722839e-10 > > > Line search: Cubically determined step, current gnorm > 1.144804970737e+02 lambda=1.5633616333063305e-10 > > > 50 SNES Function norm 1.144804970737e+02 > > > 0 SNES Function norm 2.308693894796e+03 > > > 0 KSP Residual norm 8.981999720532e+00 > > > 1 KSP Residual norm 2.363170936183e-13 > > > Line search: Using full step: fnorm 2.308693894796e+03 gnorm > 7.571661187318e+02 > > > 1 SNES Function norm 7.571661187318e+02 > > > 0 KSP Residual norm 2.149614048903e+00 > > > 1 KSP Residual norm 9.511247057888e-13 > > > Line search: Using full step: fnorm 7.571661187318e+02 gnorm > 4.450081004997e+02 > > > 2 SNES Function norm 4.450081004997e+02 > > > 0 KSP Residual norm 1.706469075123e+01 > > > 1 KSP Residual norm 5.803815175472e-13 > > > Line search: gnorm after quadratic fit 1.510518198899e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.850796532980e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.515983139755e+02 lambda=2.0602556887689423e-02 > > > Line search: Cubically determined step, current gnorm > 4.434800867235e+02 lambda=8.2396279492937211e-03 > > > 3 SNES Function norm 4.434800867235e+02 > > > 0 KSP Residual norm 3.208587171626e+00 > > > 1 KSP Residual norm 1.099072610659e-13 > > > Line search: gnorm after quadratic fit 4.080637194736e+02 > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > 4 SNES Function norm 4.080637194736e+02 > > > 0 KSP Residual norm 8.136557176540e+00 > > > 1 KSP Residual norm 8.800137844173e-13 > > > Line search: gnorm after quadratic fit 5.261656549654e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.131114070934e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm > 4.031614746044e+02 lambda=2.4674842039461482e-02 > > > 5 SNES Function norm 4.031614746044e+02 > > > 0 KSP Residual norm 7.609918907567e+00 > > > 1 KSP Residual norm 1.613159932655e-13 > > > Line search: gnorm after quadratic fit 5.353908064984e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.110480554132e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm > 3.991168240716e+02 lambda=2.3079500036735322e-02 > > > 6 SNES Function norm 3.991168240716e+02 > > > 0 KSP Residual norm 3.800845472041e+00 > > > 1 KSP Residual norm 4.841682188278e-13 > > > Line search: gnorm after quadratic fit 3.787886582952e+02 > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > 7 SNES Function norm 3.787886582952e+02 > > > 0 KSP Residual norm 1.892621919219e+00 > > > 1 KSP Residual norm 3.576655371800e-12 > > > Line search: gnorm after quadratic fit 3.440181918909e+02 > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > 8 SNES Function norm 3.440181918909e+02 > > > 0 KSP Residual norm 3.559759789147e+00 > > > 1 KSP Residual norm 8.347521826622e-13 > > > Line search: gnorm after quadratic fit 3.287993515195e+02 > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > 9 SNES Function norm 3.287993515195e+02 > > > 0 KSP Residual norm 1.825073540507e+00 > > > 1 KSP Residual norm 8.352745008123e-14 > > > Line search: Using full step: fnorm 3.287993515195e+02 gnorm > 2.710650507416e+02 > > > 10 SNES Function norm 2.710650507416e+02 > > > 0 KSP Residual norm 7.568432945608e-01 > > > 1 KSP Residual norm 2.780715252274e-14 > > > Line search: Using full step: fnorm 2.710650507416e+02 gnorm > 1.513359047342e+02 > > > 11 SNES Function norm 1.513359047342e+02 > > > 0 KSP Residual norm 9.387460484575e+00 > > > 1 KSP Residual norm 7.091233040676e-13 > > > Line search: gnorm after quadratic fit 3.998857979851e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.060972049714e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm > 1.512140169420e+02 lambda=5.4338709720680610e-03 > > > 12 SNES Function norm 1.512140169420e+02 > > > 0 KSP Residual norm 4.399424360499e+00 > > > 1 KSP Residual norm 1.614362118182e-13 > > > Line search: gnorm after quadratic fit 1.913552832643e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.559719302467e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm > 1.499985374733e+02 lambda=1.7102027220313589e-02 > > > 13 SNES Function norm 1.499985374733e+02 > > > 0 KSP Residual norm 3.740397849742e+00 > > > 1 KSP Residual norm 8.986775577006e-13 > > > Line search: gnorm after quadratic fit 1.764118876632e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.522381536119e+02 lambda=4.8196830215713270e-02 > > > Line search: Cubically determined step, current gnorm > 1.486175880390e+02 lambda=1.8881300948189364e-02 > > > 14 SNES Function norm 1.486175880390e+02 > > > 0 KSP Residual norm 6.067973818528e+00 > > > 1 KSP Residual norm 4.527845229549e-13 > > > Line search: gnorm after quadratic fit 2.514021299115e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.679972156573e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm > 1.481015724304e+02 lambda=9.0116621678703428e-03 > > > 15 SNES Function norm 1.481015724304e+02 > > > 0 KSP Residual norm 6.108754994263e+00 > > > 1 KSP Residual norm 2.557635976440e-13 > > > Line search: gnorm after quadratic fit 2.458081150104e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.681837029397e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm > 1.476148340442e+02 lambda=7.9580911933571953e-03 > > > 16 SNES Function norm 1.476148340442e+02 > > > 0 KSP Residual norm 7.914946163932e+00 > > > 1 KSP Residual norm 1.512066885699e-13 > > > Line search: gnorm after quadratic fit 3.458938604598e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.883018868359e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm > 1.474286108114e+02 lambda=6.7262521208543979e-03 > > > 17 SNES Function norm 1.474286108114e+02 > > > 0 KSP Residual norm 5.285449532689e+00 > > > 1 KSP Residual norm 6.693733977456e-12 > > > Line search: gnorm after quadratic fit 2.170263102661e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.607560548008e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm > 1.467785507822e+02 lambda=9.9244383205188240e-03 > > > 18 SNES Function norm 1.467785507822e+02 > > > 0 KSP Residual norm 8.124903695635e+00 > > > 1 KSP Residual norm 2.322439601127e-11 > > > Line search: gnorm after quadratic fit 3.589716592364e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.907315184877e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm > 1.466341888638e+02 lambda=6.5538271222582893e-03 > > > 19 SNES Function norm 1.466341888638e+02 > > > 0 KSP Residual norm 5.253550718343e+00 > > > 1 KSP Residual norm 1.575657996883e-12 > > > Line search: gnorm after quadratic fit 2.155795776725e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.598564001687e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm > 1.459869404602e+02 lambda=9.9195822632931301e-03 > > > 20 SNES Function norm 1.459869404602e+02 > > > 0 KSP Residual norm 8.405987790193e+00 > > > 1 KSP Residual norm 2.046159481178e-13 > > > Line search: gnorm after quadratic fit 3.767908298426e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.941885062002e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm > 1.458995232755e+02 lambda=6.4359684554015136e-03 > > > 21 SNES Function norm 1.458995232755e+02 > > > 0 KSP Residual norm 5.036348246593e+00 > > > 1 KSP Residual norm 3.645081669075e-13 > > > Line search: gnorm after quadratic fit 2.083222977519e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.575737508694e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm > 1.452039802458e+02 lambda=1.0554092389542354e-02 > > > 22 SNES Function norm 1.452039802458e+02 > > > 0 KSP Residual norm 8.562292355998e+00 > > > 1 KSP Residual norm 3.256332645483e-13 > > > Line search: gnorm after quadratic fit 3.869470823355e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.959483128249e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm > 1.451523830598e+02 lambda=6.3780526507799607e-03 > > > 23 SNES Function norm 1.451523830598e+02 > > > 0 KSP Residual norm 4.919667503862e+00 > > > 1 KSP Residual norm 4.823931177115e-13 > > > Line search: gnorm after quadratic fit 2.042891039525e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.560623102934e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm > 1.444331916523e+02 lambda=1.0890355421223689e-02 > > > 24 SNES Function norm 1.444331916523e+02 > > > 0 KSP Residual norm 8.727282395369e+00 > > > 1 KSP Residual norm 7.090683582186e-13 > > > Line search: gnorm after quadratic fit 3.977929422821e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.978556223200e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm > 1.444215965394e+02 lambda=6.3477766966048947e-03 > > > 25 SNES Function norm 1.444215965394e+02 > > > 0 KSP Residual norm 4.759732971179e+00 > > > 1 KSP Residual norm 7.539889498211e-13 > > > Line search: gnorm after quadratic fit 1.990589649135e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.542648241555e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm > 1.436629416941e+02 lambda=1.1434720389464151e-02 > > > 26 SNES Function norm 1.436629416941e+02 > > > 0 KSP Residual norm 8.844861828477e+00 > > > 1 KSP Residual norm 4.372001279689e-13 > > > Line search: gnorm after quadratic fit 4.055598972133e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.990820671396e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.436827663113e+02 lambda=6.3302081701296859e-03 > > > Line search: Cubically determined step, current gnorm > 1.434397789472e+02 lambda=3.1285674619640730e-03 > > > 27 SNES Function norm 1.434397789472e+02 > > > 0 KSP Residual norm 2.168630760128e+01 > > > 1 KSP Residual norm 3.975838928402e-13 > > > Line search: gnorm after quadratic fit 1.655681371309e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.972331169594e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.804118272840e+02 lambda=1.6710557456633125e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.435928635079e+02 lambda=1.6710557456633126e-03 > > > Line search: Cubically determined step, current gnorm > 1.434032742903e+02 lambda=5.1357350159978810e-04 > > > 28 SNES Function norm 1.434032742903e+02 > > > 0 KSP Residual norm 5.259508821923e+01 > > > 1 KSP Residual norm 1.358381204928e-11 > > > Line search: gnorm after quadratic fit 1.908330224731e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.431279702545e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 8.060945045253e+02 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.791318323447e+02 lambda=1.2124172979783788e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.491140019897e+02 lambda=2.6952165802905347e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.434246250245e+02 lambda=2.6952165802905350e-04 > > > Line search: Cubically determined step, current gnorm > 1.433970449422e+02 lambda=8.6980371578986910e-05 > > > 29 SNES Function norm 1.433970449422e+02 > > > 0 KSP Residual norm 1.326287161615e+02 > > > 1 KSP Residual norm 5.692176796134e-12 > > > Line search: gnorm after quadratic fit 2.077891749832e+05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.654187989332e+04 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.213029457851e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.001385334742e+03 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.323976827250e+02 lambda=5.9607661619885998e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.489839529892e+02 lambda=1.0476257410701045e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.434396736634e+02 lambda=1.0476257410701046e-04 > > > Line search: Cubically determined step, current gnorm > 1.433960671821e+02 lambda=1.3664867646895530e-05 > > > 30 SNES Function norm 1.433960671821e+02 > > > 0 KSP Residual norm 3.320710360189e+02 > > > 1 KSP Residual norm 1.365660123102e-11 > > > Line search: gnorm after quadratic fit 3.597335441013e+06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.714766420450e+05 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.566809766217e+04 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.038660363150e+04 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.026997416957e+03 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.382653551072e+02 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.071747386385e+02 lambda=1.3384948046761360e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.439693866777e+02 lambda=1.3384948046761360e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.434000505249e+02 lambda=1.3384948046761361e-05 > > > Line search: Cubically determined step, current gnorm > 1.433959111179e+02 lambda=2.1771867000079373e-06 > > > 31 SNES Function norm 1.433959111179e+02 > > > 0 KSP Residual norm 8.385024273664e+02 > > > 1 KSP Residual norm 2.688330817732e-11 > > > Line search: gnorm after quadratic fit 5.487352481970e+07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.776642694838e+06 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 8.310551423141e+05 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.023322644608e+05 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.368662233379e+04 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.472194884015e+03 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.718801059897e+02 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.274234972424e+02 lambda=6.3064412238487922e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.442194384053e+02 lambda=6.3064412238487925e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.434033578642e+02 lambda=6.3064412238487927e-06 > > > Line search: Cubically determined step, current gnorm > 1.433959042208e+02 lambda=6.3064412238487929e-07 > > > 32 SNES Function norm 1.433959042208e+02 > > > 0 KSP Residual norm 5.310191626867e+02 > > > 1 KSP Residual norm 2.270033897601e-10 > > > Line search: gnorm after quadratic fit 1.447633783740e+07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.859761774309e+06 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.472992503503e+05 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.557594026810e+04 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.969012939380e+03 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.269212161982e+03 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.859005100842e+02 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.695095262046e+02 lambda=5.4509037994531233e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.436389958907e+02 lambda=5.4509037994531237e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.433976258223e+02 lambda=5.4509037994531242e-06 > > > Line search: Cubically determined step, current gnorm > 1.433958431980e+02 lambda=8.5124820362933632e-07 > > > 33 SNES Function norm 1.433958431980e+02 > > > 0 KSP Residual norm 1.341142541825e+03 > > > 1 KSP Residual norm 4.194815344365e-11 > > > Line search: gnorm after quadratic fit 2.256410317099e+08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.797696259877e+07 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.447237377751e+06 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.221898175722e+05 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.260244723327e+04 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.539148524881e+03 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.558034531173e+03 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.788188892302e+02 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.753621043454e+02 lambda=2.4427125599600652e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.437122397600e+02 lambda=2.4427125599600654e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.433986985128e+02 lambda=2.4427125599600655e-06 > > > Line search: Cubically determined step, current gnorm > 1.433958402293e+02 lambda=2.4427125599600656e-07 > > > 34 SNES Function norm 1.433958402293e+02 > > > 0 KSP Residual norm 8.620962950418e+02 > > > 1 KSP Residual norm 4.517777375659e-11 > > > Line search: gnorm after quadratic fit 6.134442313460e+07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.790495969255e+06 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.008365220843e+06 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.364572513478e+05 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.037891335918e+04 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.640571521199e+03 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 8.472549649319e+02 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.906041216274e+02 lambda=7.6348458761785112e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.504925859329e+02 lambda=1.7740973415567094e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.434632637071e+02 lambda=1.7740973415567094e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.433962847027e+02 lambda=1.7740973415567095e-06 > > > Line search: Cubically determined step, current gnorm > 1.433958170795e+02 lambda=3.2293255704969003e-07 > > > 35 SNES Function norm 1.433958170795e+02 > > > 0 KSP Residual norm 2.177497039945e+03 > > > 1 KSP Residual norm 8.546235181505e-11 > > > Line search: gnorm after quadratic fit 9.689178330938e+08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.204850731541e+08 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.491460480376e+07 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.833699292784e+06 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.246639021599e+05 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.860166571872e+04 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.484329051490e+03 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.050411687443e+03 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.488366972009e+02 lambda=3.7767265396089055e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.508326035050e+02 lambda=7.2725649346261757e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.434696063559e+02 lambda=7.2725649346261764e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.433964618996e+02 lambda=7.2725649346261768e-07 > > > Line search: Cubically determined step, current gnorm > 1.433958141405e+02 lambda=7.2725649346261771e-08 > > > 36 SNES Function norm 1.433958141405e+02 > > > 0 KSP Residual norm 2.164813477994e+03 > > > 1 KSP Residual norm 1.148881458292e-10 > > > Line search: gnorm after quadratic fit 9.626940870744e+08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.210459267934e+08 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.531855101756e+07 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.966826097072e+06 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.611808255272e+05 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.746062783262e+04 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.252259871244e+03 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.319447372021e+03 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.963055448218e+02 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.719034797105e+02 lambda=1.3935000445038475e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.436664111092e+02 lambda=1.3935000445038476e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.433983336239e+02 lambda=1.3935000445038476e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.433958213497e+02 lambda=1.3935000445038476e-07 > > > Line search: Cubically determined step, current gnorm > 1.433958104705e+02 lambda=5.1202466521517630e-08 > > > 37 SNES Function norm 1.433958104705e+02 > > > 0 KSP Residual norm 5.470482746849e+03 > > > 1 KSP Residual norm 2.077456833170e-10 > > > Line search: gnorm after quadratic fit 1.541335606193e+10 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.922526157954e+09 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.393079394383e+08 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.967573549050e+07 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.657319925168e+06 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.479516204895e+05 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.573399122917e+04 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.931177424479e+03 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.619710606187e+03 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.924551713717e+02 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.786095404459e+02 lambda=6.2808469554243522e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.437467476469e+02 lambda=6.2808469554243527e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.433992463439e+02 lambda=6.2808469554243527e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.433958367271e+02 lambda=6.2808469554243525e-08 > > > Line search: Cubically determined step, current gnorm > 1.433958098948e+02 lambda=8.0208105170108588e-09 > > > 38 SNES Function norm 1.433958098948e+02 > > > 0 KSP Residual norm 1.380568582849e+04 > > > 1 KSP Residual norm 3.830866223513e-10 > > > Line search: gnorm after quadratic fit 2.484973518314e+11 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.108953896984e+10 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.893104137528e+09 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.884003910853e+08 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.150765563542e+07 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.811161146103e+06 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.011017986781e+06 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.368084343451e+05 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.042876665700e+04 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.648735196752e+03 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 8.489051252413e+02 lambda=9.7656250000000005e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.910677756717e+02 lambda=4.7728537787817724e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.505452645186e+02 lambda=1.1099980464343249e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.434658984864e+02 lambda=1.1099980464343249e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.433964956476e+02 lambda=1.1099980464343249e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.433958153212e+02 lambda=1.1099980464343250e-08 > > > Line search: Cubically determined step, current gnorm > 1.433958098048e+02 lambda=1.2587012037197021e-09 > > > 39 SNES Function norm 1.433958098048e+02 > > > 0 KSP Residual norm 3.492284741552e+04 > > > 1 KSP Residual norm 2.459788921244e-09 > > > Line search: gnorm after quadratic fit 4.017424324975e+12 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.020053801097e+11 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.270768402853e+10 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.827801904036e+09 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 9.758550488105e+08 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.213492627852e+08 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.502191365805e+07 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.846947104704e+06 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.262850216093e+05 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.879926646684e+04 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.510203332079e+03 lambda=9.7656250000000005e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.055028679619e+03 lambda=4.8828125000000003e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.503903269554e+02 lambda=2.3633949212111800e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.510245991472e+02 lambda=4.5897967908360529e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.434724062782e+02 lambda=4.5897967908360533e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.433965706606e+02 lambda=4.5897967908360533e-08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.433958168196e+02 lambda=4.5897967908360538e-09 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.433958098155e+02 lambda=4.5897967908360540e-10 > > > Line search: Cubically determined step, current gnorm > 1.433958097906e+02 lambda=1.9745369723997599e-10 > > > 40 SNES Function norm 1.433958097906e+02 > > > 0 KSP Residual norm 8.722495521587e+04 > > > 1 KSP Residual norm 3.742695919275e-09 > > > Line search: gnorm after quadratic fit 6.262538457180e+13 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.829256308992e+12 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 9.789282877890e+11 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.224340679566e+11 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.532137613500e+10 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.919506047737e+09 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.410488718338e+08 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.042211373104e+07 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.881986305609e+06 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.080857001861e+05 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.054449734307e+04 lambda=9.7656250000000005e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.109051581397e+04 lambda=4.8828125000000003e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.144985497099e+03 lambda=2.4414062500000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.617627947761e+02 lambda=1.2207031250000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.132828960986e+02 lambda=5.3137869181552773e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.440403409760e+02 lambda=5.3137869181552777e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.434022226216e+02 lambda=5.3137869181552781e-08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.433958732177e+02 lambda=5.3137869181552781e-09 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.433958103569e+02 lambda=5.3137869181552779e-10 > > > Line search: Cubically determined step, current gnorm > 1.433958097894e+02 lambda=5.3137869181552781e-11 > > > 41 SNES Function norm 1.433958097894e+02 > > > 0 KSP Residual norm 6.453169081212e+04 > > > 1 KSP Residual norm 2.762540688686e-09 > > > Line search: gnorm after quadratic fit 2.535166112592e+13 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.168366990040e+12 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.958985371462e+11 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.945064622488e+10 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.172244865713e+09 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.693002384290e+08 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 9.562568994785e+07 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.182957296890e+07 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.453260254263e+06 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.781984147743e+05 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.294934468515e+04 lambda=9.7656250000000005e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.740461720782e+03 lambda=4.8828125000000003e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 9.162621855154e+02 lambda=2.4414062500000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.042417294890e+02 lambda=1.1290474210136388e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.458920680477e+02 lambda=1.4201366604660443e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.434208620254e+02 lambda=1.4201366604660444e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.433960586269e+02 lambda=1.4201366604660445e-08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.433958120934e+02 lambda=1.4201366604660445e-09 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.433958097940e+02 lambda=1.4201366604660446e-10 > > > Line search: Cubically determined step, current gnorm > 1.433958097852e+02 lambda=5.7981795207229486e-11 > > > 42 SNES Function norm 1.433958097852e+02 > > > 0 KSP Residual norm 1.596625793747e+05 > > > 1 KSP Residual norm 6.465899717071e-09 > > > Line search: gnorm after quadratic fit 3.840699863976e+14 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.801237514773e+13 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.002454410823e+12 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.505340831651e+11 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 9.387378188418e+10 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.174857842415e+10 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.472211181784e+09 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.849608933788e+08 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.336592011613e+07 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.988079805895e+06 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.930858080425e+05 lambda=9.7656250000000005e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.521190722497e+04 lambda=4.8828125000000003e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 8.872153015323e+03 lambda=2.4414062500000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.772337662956e+03 lambda=1.2207031250000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.879470852054e+02 lambda=6.1035156250000003e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.942774855488e+02 lambda=2.4957912736226801e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.438719078958e+02 lambda=2.4957912736226800e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.434005516391e+02 lambda=2.4957912736226800e-08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.433958568732e+02 lambda=2.4957912736226803e-09 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.433958102244e+02 lambda=2.4957912736226804e-10 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.433958097865e+02 lambda=2.4957912736226805e-11 > > > Line search: Cubically determined step, current gnorm > 1.433958097846e+02 lambda=9.2900433293108317e-12 > > > 43 SNES Function norm 1.433958097846e+02 > > > 0 KSP Residual norm 4.230869747157e+05 > > > 1 KSP Residual norm 2.238707423027e-08 > > > Line search: gnorm after quadratic fit 7.145700515048e+15 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 8.931871281700e+14 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.116420341041e+14 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.395366610168e+13 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.743811756566e+12 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.178776103292e+11 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.721012032848e+10 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.395186924428e+09 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.229125978585e+08 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.250971135953e+07 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.483856203094e+06 lambda=9.7656250000000005e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.950671355228e+05 lambda=4.8828125000000003e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 9.795408218555e+04 lambda=2.4414062500000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.315025696280e+04 lambda=1.2207031250000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.395961070555e+03 lambda=6.1035156250000003e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.565070307576e+02 lambda=3.0517578125000002e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.228949713871e+02 lambda=1.2154989071946628e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.441831998014e+02 lambda=1.2154989071946629e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.434037055996e+02 lambda=1.2154989071946630e-08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.433958886074e+02 lambda=1.2154989071946630e-09 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.433958105564e+02 lambda=1.2154989071946630e-10 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.433958097907e+02 lambda=1.2154989071946631e-11 > > > Line search: Cubically determined step, current gnorm > 1.433958097845e+02 lambda=1.3559489351735629e-12 > > > 44 SNES Function norm 1.433958097845e+02 > > > 0 KSP Residual norm 1.017589039922e+06 > > > 1 KSP Residual norm 5.483283808994e-08 > > > Line search: gnorm after quadratic fit 9.942386816509e+16 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.242813073279e+16 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.553553149772e+15 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.942033483320e+14 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.427772097758e+13 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.035291372732e+12 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.795558047824e+11 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.748073147307e+10 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.944235240368e+09 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.453550734860e+08 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 9.377045707707e+07 lambda=9.7656250000000005e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.188119937132e+07 lambda=4.8828125000000003e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.529730353136e+06 lambda=2.4414062500000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.044646611329e+05 lambda=1.2207031250000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.974477616118e+04 lambda=6.1035156250000003e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.087923877078e+03 lambda=3.0517578125000002e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.112257173311e+03 lambda=1.5258789062500001e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.536190077033e+02 lambda=7.6293945312500004e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.622567424729e+02 lambda=2.4244966960965791e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.435780438142e+02 lambda=2.4244966960965793e-08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.433976282603e+02 lambda=2.4244966960965796e-09 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.433958279382e+02 lambda=2.4244966960965797e-10 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.433958099632e+02 lambda=2.4244966960965799e-11 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.433958097860e+02 lambda=2.4244966960965801e-12 > > > Line search: Cubically determined step, current gnorm > 1.433958097845e+02 lambda=2.4244966960965801e-13 > > > 45 SNES Function norm 1.433958097845e+02 > > > 0 KSP Residual norm 2.206687220910e+06 > > > 1 KSP Residual norm 4.897651438902e-08 > > > Line search: gnorm after quadratic fit 1.013883843512e+18 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.267347883019e+17 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.584167551460e+16 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.980166189110e+15 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.475099638694e+14 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.093604443378e+13 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.866330988164e+12 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.831230804145e+11 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.034848618023e+10 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.533173457427e+09 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 9.390937545910e+08 lambda=9.7656250000000005e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.167706366282e+08 lambda=4.8828125000000003e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.445357932595e+07 lambda=2.4414062500000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.776833600920e+06 lambda=1.2207031250000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.177171496134e+05 lambda=6.1035156250000003e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.775750596740e+04 lambda=3.0517578125000002e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.374283858049e+03 lambda=1.5258789062500001e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.030949543491e+03 lambda=7.6293945312500004e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.423064811256e+02 lambda=3.6673216108643130e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.499924205417e+02 lambda=6.7541706529544844e-08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.434620968378e+02 lambda=6.7541706529544851e-09 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.433964732224e+02 lambda=6.7541706529544853e-10 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.433958164087e+02 lambda=6.7541706529544856e-11 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.433958098496e+02 lambda=6.7541706529544860e-12 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.433958097850e+02 lambda=6.7541706529544869e-13 > > > Line search: unable to find good step length! After 24 tries > > > Line search: fnorm=1.4339580978447020e+02, > gnorm=1.4339580978501337e+02, ynorm=2.2066872446260620e+06, > minlambda=9.9999999999999998e-13, lambda=6.7541706529544869e-13, initial > slope=-2.0562359199040133e+04 > > > 0 SNES Function norm 7.494832241120e+03 > > > 0 KSP Residual norm 2.096735360816e+01 > > > 1 KSP Residual norm 1.310027756820e-12 > > > Line search: gnorm after quadratic fit 6.728375857515e+03 > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > 1 SNES Function norm 6.728375857515e+03 > > > 0 KSP Residual norm 2.051806116405e+01 > > > 1 KSP Residual norm 4.624620138831e-13 > > > Line search: gnorm after quadratic fit 6.028616261650e+03 > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > 2 SNES Function norm 6.028616261650e+03 > > > 0 KSP Residual norm 2.416503160016e+01 > > > 1 KSP Residual norm 8.456041680630e-13 > > > Line search: gnorm after quadratic fit 5.407473517447e+03 > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > 3 SNES Function norm 5.407473517447e+03 > > > 0 KSP Residual norm 1.429873750399e+01 > > > 1 KSP Residual norm 2.956316145819e-13 > > > Line search: Using full step: fnorm 5.407473517447e+03 gnorm > 1.894530516076e+03 > > > 4 SNES Function norm 1.894530516076e+03 > > > 0 KSP Residual norm 2.898580554597e+00 > > > 1 KSP Residual norm 6.622560162623e-14 > > > Line search: Using full step: fnorm 1.894530516076e+03 gnorm > 1.794029421846e+03 > > > 5 SNES Function norm 1.794029421846e+03 > > > 0 KSP Residual norm 1.749678611959e+01 > > > 1 KSP Residual norm 8.138905825078e-12 > > > Line search: gnorm after quadratic fit 1.767361408940e+03 > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > 6 SNES Function norm 1.767361408940e+03 > > > 0 KSP Residual norm 1.094404109423e+02 > > > 1 KSP Residual norm 7.696691527700e-12 > > > Line search: gnorm after quadratic fit 3.545750923895e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.153479540314e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.205683629874e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.802976525485e+03 lambda=1.2441094586006883e-02 > > > Line search: Cubically determined step, current gnorm > 1.765063299263e+03 lambda=4.9240328094708914e-03 > > > 7 SNES Function norm 1.765063299263e+03 > > > 0 KSP Residual norm 1.778095975189e+01 > > > 1 KSP Residual norm 2.814661813934e-12 > > > Line search: gnorm after quadratic fit 2.620761680117e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.793045753271e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm > 1.740299227935e+03 lambda=2.5000000000000001e-02 > > > 8 SNES Function norm 1.740299227935e+03 > > > 0 KSP Residual norm 3.284236894535e+02 > > > 1 KSP Residual norm 5.172103783952e-10 > > > Line search: gnorm after quadratic fit 2.857820523902e+05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.063993491139e+04 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.588139591650e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.491163684413e+03 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.802614760566e+03 lambda=5.7977212395253904e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.741444490992e+03 lambda=1.8448315876950813e-03 > > > Line search: Cubically determined step, current gnorm > 1.739663656043e+03 lambda=7.7468345598227730e-04 > > > 9 SNES Function norm 1.739663656043e+03 > > > 0 KSP Residual norm 4.581839103558e+02 > > > 1 KSP Residual norm 2.627035885943e-11 > > > Line search: gnorm after quadratic fit 8.199478499066e+05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.127270076812e+05 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.816774161281e+04 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.053723877333e+03 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.971814513392e+03 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.755066208174e+03 lambda=2.7232010924558834e-03 > > > Line search: Cubically determined step, current gnorm > 1.739559834479e+03 lambda=8.1458417855297680e-04 > > > 10 SNES Function norm 1.739559834479e+03 > > > 0 KSP Residual norm 1.463056810139e+02 > > > 1 KSP Residual norm 5.383584598825e-12 > > > Line search: gnorm after quadratic fit 2.885699620595e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.847717401708e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.244464170034e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.769157604338e+03 lambda=1.0857209099577540e-02 > > > Line search: Cubically determined step, current gnorm > 1.737356225452e+03 lambda=4.0312937622950231e-03 > > > 11 SNES Function norm 1.737356225452e+03 > > > 0 KSP Residual norm 1.564105677925e+02 > > > 1 KSP Residual norm 6.671164745832e-11 > > > Line search: gnorm after quadratic fit 3.815800291873e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.197027796134e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.373151605545e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.783976520867e+03 lambda=1.2093374970461970e-02 > > > Line search: Cubically determined step, current gnorm > 1.735737929915e+03 lambda=4.9529698477569920e-03 > > > 12 SNES Function norm 1.735737929915e+03 > > > 0 KSP Residual norm 5.030757139645e+01 > > > 1 KSP Residual norm 1.157542730692e-12 > > > Line search: gnorm after quadratic fit 3.004544441458e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.850403239750e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm > 1.722893188305e+03 lambda=2.0881992439921702e-02 > > > 13 SNES Function norm 1.722893188305e+03 > > > 0 KSP Residual norm 7.123428853845e+01 > > > 1 KSP Residual norm 8.671726774894e-12 > > > Line search: gnorm after quadratic fit 4.361041499279e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.032697222107e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.726212330814e+03 lambda=1.9909470348267504e-02 > > > Line search: Cubically determined step, current gnorm > 1.714127356920e+03 lambda=9.9547351741337518e-03 > > > 14 SNES Function norm 1.714127356920e+03 > > > 0 KSP Residual norm 8.304557447257e+00 > > > 1 KSP Residual norm 6.268295862688e-13 > > > Line search: gnorm after quadratic fit 1.558163002487e+03 > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > 15 SNES Function norm 1.558163002487e+03 > > > 0 KSP Residual norm 2.820803287164e+00 > > > 1 KSP Residual norm 5.477413853752e-13 > > > Line search: gnorm after quadratic fit 1.065673478530e+03 > > > Line search: Quadratically determined step, > lambda=3.8943438938591052e-01 > > > 16 SNES Function norm 1.065673478530e+03 > > > 0 KSP Residual norm 2.296739120664e+00 > > > 1 KSP Residual norm 6.273731899885e-14 > > > Line search: gnorm after quadratic fit 8.964342150621e+02 > > > Line search: Quadratically determined step, > lambda=1.8740736900935545e-01 > > > 17 SNES Function norm 8.964342150621e+02 > > > 0 KSP Residual norm 5.567568505830e+00 > > > 1 KSP Residual norm 8.649083600764e-12 > > > Line search: gnorm after quadratic fit 8.322514858992e+02 > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > 18 SNES Function norm 8.322514858992e+02 > > > 0 KSP Residual norm 1.164393577210e+00 > > > 1 KSP Residual norm 2.019248309015e-14 > > > Line search: Using full step: fnorm 8.322514858992e+02 gnorm > 3.179750274746e+02 > > > 19 SNES Function norm 3.179750274746e+02 > > > 0 KSP Residual norm 5.339294310641e+00 > > > 1 KSP Residual norm 2.070321587238e-13 > > > Line search: gnorm after quadratic fit 3.433012316833e+02 > > > Line search: Cubically determined step, current gnorm > 3.140305403821e+02 lambda=5.0000000000000003e-02 > > > 20 SNES Function norm 3.140305403821e+02 > > > 0 KSP Residual norm 1.177016565578e+01 > > > 1 KSP Residual norm 2.413027540446e-13 > > > Line search: gnorm after quadratic fit 7.377851778409e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.896721016582e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm > 3.136619309181e+02 lambda=9.7219892278716195e-03 > > > 21 SNES Function norm 3.136619309181e+02 > > > 0 KSP Residual norm 3.973565083977e+00 > > > 1 KSP Residual norm 9.726786674410e-14 > > > Line search: gnorm after quadratic fit 3.098277326090e+02 > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > 22 SNES Function norm 3.098277326090e+02 > > > 0 KSP Residual norm 9.389290683519e+00 > > > 1 KSP Residual norm 1.651497163724e-13 > > > Line search: gnorm after quadratic fit 6.887970540455e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.588146381477e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.099274823603e+02 lambda=1.6890426151283184e-02 > > > Line search: Cubically determined step, current gnorm > 3.084890760827e+02 lambda=8.4452130756415920e-03 > > > 23 SNES Function norm 3.084890760827e+02 > > > 0 KSP Residual norm 2.381130479641e+00 > > > 1 KSP Residual norm 4.694489283156e-14 > > > Line search: gnorm after quadratic fit 2.872151876535e+02 > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > 24 SNES Function norm 2.872151876535e+02 > > > 0 KSP Residual norm 2.405498502269e+00 > > > 1 KSP Residual norm 3.316846070538e-13 > > > Line search: gnorm after quadratic fit 2.686789761232e+02 > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > 25 SNES Function norm 2.686789761232e+02 > > > 0 KSP Residual norm 1.728772970554e+00 > > > 1 KSP Residual norm 4.132974383339e-14 > > > Line search: gnorm after quadratic fit 2.365009918229e+02 > > > Line search: Quadratically determined step, > lambda=1.7273357529379074e-01 > > > 26 SNES Function norm 2.365009918229e+02 > > > 0 KSP Residual norm 4.413764759374e+00 > > > 1 KSP Residual norm 5.210690816917e-14 > > > Line search: gnorm after quadratic fit 2.756730968257e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.372321757171e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm > 2.335020811250e+02 lambda=2.5000000000000001e-02 > > > 27 SNES Function norm 2.335020811250e+02 > > > 0 KSP Residual norm 1.606246507553e+00 > > > 1 KSP Residual norm 3.564847846678e-14 > > > Line search: gnorm after quadratic fit 2.078263630653e+02 > > > Line search: Quadratically determined step, > lambda=1.5913860995949433e-01 > > > 28 SNES Function norm 2.078263630653e+02 > > > 0 KSP Residual norm 3.700632954873e+00 > > > 1 KSP Residual norm 5.113863400264e-13 > > > Line search: gnorm after quadratic fit 2.142503514807e+02 > > > Line search: Cubically determined step, current gnorm > 2.021095009118e+02 lambda=5.0000000000000003e-02 > > > 29 SNES Function norm 2.021095009118e+02 > > > 0 KSP Residual norm 3.056449560135e+00 > > > 1 KSP Residual norm 3.207987681334e-14 > > > Line search: gnorm after quadratic fit 2.064252530802e+02 > > > Line search: Cubically determined step, current gnorm > 1.978069081639e+02 lambda=5.0000000000000003e-02 > > > 30 SNES Function norm 1.978069081639e+02 > > > 0 KSP Residual norm 2.024695620703e+00 > > > 1 KSP Residual norm 5.460360737995e-14 > > > Line search: gnorm after quadratic fit 1.839556530796e+02 > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > 31 SNES Function norm 1.839556530796e+02 > > > 0 KSP Residual norm 1.610676619931e+01 > > > 1 KSP Residual norm 6.703552136307e-13 > > > Line search: gnorm after quadratic fit 7.186735314913e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.905672430097e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.856766286600e+02 lambda=1.0830798014298563e-02 > > > Line search: Cubically determined step, current gnorm > 1.836818937131e+02 lambda=3.3207362501459785e-03 > > > 32 SNES Function norm 1.836818937131e+02 > > > 0 KSP Residual norm 7.471722173131e+01 > > > 1 KSP Residual norm 2.671534648829e-12 > > > Line search: gnorm after quadratic fit 9.613379909411e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.509491298762e+04 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.808861367705e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.767283758299e+02 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.665421328348e+02 lambda=6.0369453941238101e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.869726717041e+02 lambda=1.4394327006264963e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.836897704575e+02 lambda=1.4394327006264963e-04 > > > Line search: Cubically determined step, current gnorm > 1.836767951408e+02 lambda=5.5567420418543164e-05 > > > 33 SNES Function norm 1.836767951408e+02 > > > 0 KSP Residual norm 2.702367712138e+01 > > > 1 KSP Residual norm 2.731656687850e-12 > > > Line search: gnorm after quadratic fit 3.331563146098e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 8.723694790688e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.941243220944e+02 lambda=2.1443568774664485e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.847231733910e+02 lambda=2.7571330376860012e-03 > > > Line search: Cubically determined step, current gnorm > 1.836356729409e+02 lambda=4.7841280418270480e-04 > > > 34 SNES Function norm 1.836356729409e+02 > > > 0 KSP Residual norm 1.228333177997e+01 > > > 1 KSP Residual norm 2.681127387880e-13 > > > Line search: gnorm after quadratic fit 6.936329223475e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.749327218775e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.871557327742e+02 lambda=1.4160505301999991e-02 > > > Line search: Cubically determined step, current gnorm > 1.833523080682e+02 lambda=3.5196326548579192e-03 > > > 35 SNES Function norm 1.833523080682e+02 > > > 0 KSP Residual norm 3.531886257396e+02 > > > 1 KSP Residual norm 2.364634092895e-11 > > > Line search: gnorm after quadratic fit 3.994783047929e+06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.753715960726e+05 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.516669898185e+04 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.918985942348e+03 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.363599250418e+03 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.344906818752e+02 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.991088183980e+02 lambda=1.0108094710462592e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.834621681844e+02 lambda=1.0108094710462593e-04 > > > Line search: Cubically determined step, current gnorm > 1.833517377324e+02 lambda=1.0108094710462594e-05 > > > 36 SNES Function norm 1.833517377324e+02 > > > 0 KSP Residual norm 9.005833507118e+01 > > > 1 KSP Residual norm 6.116387880629e-12 > > > Line search: gnorm after quadratic fit 8.899847103226e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.388111536526e+04 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.532652074749e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.864912734009e+02 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.421068789960e+02 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.873498120960e+02 lambda=2.1924025345283278e-03 > > > Line search: Cubically determined step, current gnorm > 1.833506987706e+02 lambda=2.1924025345283280e-04 > > > 37 SNES Function norm 1.833506987706e+02 > > > 0 KSP Residual norm 1.548426525207e+01 > > > 1 KSP Residual norm 1.038038773942e-12 > > > Line search: gnorm after quadratic fit 6.702848665441e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.789880616078e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.846521504351e+02 lambda=1.0567302644323170e-02 > > > Line search: Cubically determined step, current gnorm > 1.830548481815e+02 lambda=3.5274490352771972e-03 > > > 38 SNES Function norm 1.830548481815e+02 > > > 0 KSP Residual norm 1.523095478807e+01 > > > 1 KSP Residual norm 1.963823596119e-12 > > > Line search: gnorm after quadratic fit 9.255727478491e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.496757253461e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.863126241242e+02 lambda=9.3143291632966311e-03 > > > Line search: Cubically determined step, current gnorm > 1.829091761403e+02 lambda=1.8107234819462800e-03 > > > 39 SNES Function norm 1.829091761403e+02 > > > 0 KSP Residual norm 1.311320726934e+01 > > > 1 KSP Residual norm 9.084170520902e-13 > > > Line search: gnorm after quadratic fit 7.488610069188e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.691148243365e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.885558228772e+02 lambda=1.9439894235886539e-02 > > > Line search: Cubically determined step, current gnorm > 1.825540619134e+02 lambda=5.4967824488704169e-03 > > > 40 SNES Function norm 1.825540619134e+02 > > > 0 KSP Residual norm 1.218635557505e+01 > > > 1 KSP Residual norm 7.760485728617e-13 > > > Line search: gnorm after quadratic fit 6.636453826807e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.880828006022e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.830493790584e+02 lambda=6.6234802648049863e-03 > > > Line search: Cubically determined step, current gnorm > 1.823397545268e+02 lambda=2.4308217464828865e-03 > > > 41 SNES Function norm 1.823397545268e+02 > > > 0 KSP Residual norm 9.456543593865e+00 > > > 1 KSP Residual norm 7.046593270309e-13 > > > Line search: gnorm after quadratic fit 3.369769163110e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.105230957789e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm > 1.817897533119e+02 lambda=9.1612481372917148e-03 > > > 42 SNES Function norm 1.817897533119e+02 > > > 0 KSP Residual norm 7.290035145805e+00 > > > 1 KSP Residual norm 3.198962158141e-12 > > > Line search: gnorm after quadratic fit 2.858311567415e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.965004842981e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm > 1.808845577764e+02 lambda=1.3826421990147811e-02 > > > 43 SNES Function norm 1.808845577764e+02 > > > 0 KSP Residual norm 7.256785036157e+00 > > > 1 KSP Residual norm 9.243179217625e-14 > > > Line search: gnorm after quadratic fit 2.534388176390e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.916726818893e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm > 1.797953125543e+02 lambda=1.3677747819164022e-02 > > > 44 SNES Function norm 1.797953125543e+02 > > > 0 KSP Residual norm 1.716201096352e+01 > > > 1 KSP Residual norm 2.701418800808e-13 > > > Line search: gnorm after quadratic fit 1.331064301474e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.461842246267e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.920668830294e+02 lambda=1.2856504859057132e-02 > > > Line search: Cubically determined step, current gnorm > 1.797121460957e+02 lambda=1.4396611381500967e-03 > > > 45 SNES Function norm 1.797121460957e+02 > > > 0 KSP Residual norm 6.613432967985e+00 > > > 1 KSP Residual norm 1.357752977076e-13 > > > Line search: gnorm after quadratic fit 2.721288927858e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.939638282615e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm > 1.787985482018e+02 lambda=1.2647907914070569e-02 > > > 46 SNES Function norm 1.787985482018e+02 > > > 0 KSP Residual norm 1.225736349281e+01 > > > 1 KSP Residual norm 3.819378790812e-13 > > > Line search: gnorm after quadratic fit 4.548006065036e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.304803559060e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm > 1.787344729174e+02 lambda=8.9002284237256531e-03 > > > 47 SNES Function norm 1.787344729174e+02 > > > 0 KSP Residual norm 6.302465402340e+00 > > > 1 KSP Residual norm 6.980931947122e-14 > > > Line search: gnorm after quadratic fit 2.879477700004e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.980806946742e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm > 1.780128006935e+02 lambda=1.0223293444602008e-02 > > > 48 SNES Function norm 1.780128006935e+02 > > > 0 KSP Residual norm 4.323829277968e+00 > > > 1 KSP Residual norm 5.223881369308e-13 > > > Line search: gnorm after quadratic fit 1.957928151218e+02 > > > Line search: Cubically determined step, current gnorm > 1.768899805640e+02 lambda=5.0000000000000003e-02 > > > 49 SNES Function norm 1.768899805640e+02 > > > 0 KSP Residual norm 2.249256107033e+00 > > > 1 KSP Residual norm 3.624400957270e-14 > > > Line search: gnorm after quadratic fit 1.704782114773e+02 > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > 50 SNES Function norm 1.704782114773e+02 > > > 0 SNES Function norm 3.513783397332e+03 > > > 0 KSP Residual norm 1.650214950648e+01 > > > 1 KSP Residual norm 3.574269752690e-13 > > > Line search: gnorm after quadratic fit 3.155830404050e+03 > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > 1 SNES Function norm 3.155830404050e+03 > > > 0 KSP Residual norm 1.443734018042e+01 > > > 1 KSP Residual norm 3.685565191058e-13 > > > Line search: Using full step: fnorm 3.155830404050e+03 gnorm > 8.581212204155e+02 > > > 2 SNES Function norm 8.581212204155e+02 > > > 0 KSP Residual norm 2.492601775565e+00 > > > 1 KSP Residual norm 9.698440210389e-14 > > > Line search: Using full step: fnorm 8.581212204155e+02 gnorm > 7.018609898542e+02 > > > 3 SNES Function norm 7.018609898542e+02 > > > 0 KSP Residual norm 1.740320986421e+00 > > > 1 KSP Residual norm 2.868780682435e-14 > > > Line search: Using full step: fnorm 7.018609898542e+02 gnorm > 2.135824235887e+02 > > > 4 SNES Function norm 2.135824235887e+02 > > > 0 KSP Residual norm 1.647413497077e+00 > > > 1 KSP Residual norm 2.731226225666e-14 > > > Line search: gnorm after quadratic fit 1.936469032649e+02 > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > 5 SNES Function norm 1.936469032649e+02 > > > 0 KSP Residual norm 1.406615972124e+00 > > > 1 KSP Residual norm 3.167179626699e-14 > > > Line search: gnorm after quadratic fit 1.755362571467e+02 > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > 6 SNES Function norm 1.755362571467e+02 > > > 0 KSP Residual norm 1.480681706594e+00 > > > 1 KSP Residual norm 2.935210968935e-14 > > > Line search: gnorm after quadratic fit 1.597659506616e+02 > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > 7 SNES Function norm 1.597659506616e+02 > > > 0 KSP Residual norm 4.013154698097e+00 > > > 1 KSP Residual norm 1.021628704832e-13 > > > Line search: gnorm after quadratic fit 1.728408060966e+02 > > > Line search: Cubically determined step, current gnorm > 1.570815760721e+02 lambda=5.0000000000000003e-02 > > > 8 SNES Function norm 1.570815760721e+02 > > > 0 KSP Residual norm 1.510335662636e+00 > > > 1 KSP Residual norm 2.728243244724e-14 > > > Line search: gnorm after quadratic fit 1.450162880692e+02 > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > 9 SNES Function norm 1.450162880692e+02 > > > 0 KSP Residual norm 1.923349271077e+01 > > > 1 KSP Residual norm 1.640711956406e-11 > > > Line search: gnorm after quadratic fit 1.016537223115e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.584263092048e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.490729346583e+02 lambda=9.3725990358703350e-03 > > > Line search: Cubically determined step, current gnorm > 1.449349273006e+02 lambda=1.5464889706033082e-03 > > > 10 SNES Function norm 1.449349273006e+02 > > > 0 KSP Residual norm 1.154999084194e+01 > > > 1 KSP Residual norm 1.292167633338e-11 > > > Line search: gnorm after quadratic fit 6.060386918705e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.236630526035e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.491201927819e+02 lambda=1.6816056300124185e-02 > > > Line search: Cubically determined step, current gnorm > 1.447023047013e+02 lambda=4.1484374564153808e-03 > > > 11 SNES Function norm 1.447023047013e+02 > > > 0 KSP Residual norm 7.278906180502e+00 > > > 1 KSP Residual norm 2.815632651924e-12 > > > Line search: gnorm after quadratic fit 2.512278711773e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.624350957814e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm > 1.441656049510e+02 lambda=1.0879389002513012e-02 > > > 12 SNES Function norm 1.441656049510e+02 > > > 0 KSP Residual norm 4.449836480267e+00 > > > 1 KSP Residual norm 3.152365624813e-13 > > > Line search: gnorm after quadratic fit 1.749680739878e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.458763435996e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm > 1.425715025152e+02 lambda=2.2766809271842225e-02 > > > 13 SNES Function norm 1.425715025152e+02 > > > 0 KSP Residual norm 4.218495037726e+00 > > > 1 KSP Residual norm 1.398472536142e-12 > > > Line search: gnorm after quadratic fit 1.645159536467e+02 > > > Line search: Cubically determined step, current gnorm > 1.421991559212e+02 lambda=4.1883769431247941e-02 > > > 14 SNES Function norm 1.421991559212e+02 > > > 0 KSP Residual norm 1.968853538608e+00 > > > 1 KSP Residual norm 7.594023450519e-12 > > > Line search: gnorm after quadratic fit 1.350960142124e+02 > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > 15 SNES Function norm 1.350960142124e+02 > > > 0 KSP Residual norm 3.444721686085e+00 > > > 1 KSP Residual norm 5.312609674019e-14 > > > Line search: gnorm after quadratic fit 1.472880565107e+02 > > > Line search: Cubically determined step, current gnorm > 1.336714620145e+02 lambda=4.1341550820829437e-02 > > > 16 SNES Function norm 1.336714620145e+02 > > > 0 KSP Residual norm 3.276288899397e+00 > > > 1 KSP Residual norm 8.394674946715e-14 > > > Line search: gnorm after quadratic fit 1.459274497150e+02 > > > Line search: Cubically determined step, current gnorm > 1.327618539486e+02 lambda=5.0000000000000003e-02 > > > 17 SNES Function norm 1.327618539486e+02 > > > 0 KSP Residual norm 2.630052244303e+00 > > > 1 KSP Residual norm 4.351283410507e-14 > > > Line search: gnorm after quadratic fit 1.350378060116e+02 > > > Line search: Cubically determined step, current gnorm > 1.299403903934e+02 lambda=4.9913529436269283e-02 > > > 18 SNES Function norm 1.299403903934e+02 > > > 0 KSP Residual norm 6.124953430138e+00 > > > 1 KSP Residual norm 2.295381352938e-13 > > > Line search: gnorm after quadratic fit 2.275621676963e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.469611730657e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm > 1.294890694898e+02 lambda=1.0071939100661648e-02 > > > 19 SNES Function norm 1.294890694898e+02 > > > 0 KSP Residual norm 1.036733907011e+01 > > > 1 KSP Residual norm 1.800941381283e-13 > > > Line search: gnorm after quadratic fit 3.844879463595e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.875071148504e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm > 1.294494430642e+02 lambda=5.0000000000000010e-03 > > > 20 SNES Function norm 1.294494430642e+02 > > > 0 KSP Residual norm 8.224001595443e+00 > > > 1 KSP Residual norm 3.337810156182e-13 > > > Line search: gnorm after quadratic fit 3.332325263497e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.682441841234e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.294720538860e+02 lambda=8.5401597581228530e-03 > > > Line search: Cubically determined step, current gnorm > 1.291762382985e+02 lambda=4.2555418164960989e-03 > > > 21 SNES Function norm 1.291762382985e+02 > > > 0 KSP Residual norm 3.920749219860e+01 > > > 1 KSP Residual norm 1.610902886435e-12 > > > Line search: gnorm after quadratic fit 3.472422440640e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.023065712859e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.228184088700e+02 lambda=1.6004598823093592e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.298607525058e+02 lambda=1.6004598823093593e-03 > > > Line search: Cubically determined step, current gnorm > 1.291643460998e+02 lambda=1.9319076533745672e-04 > > > 22 SNES Function norm 1.291643460998e+02 > > > 0 KSP Residual norm 1.520092314848e+02 > > > 1 KSP Residual norm 7.089159192434e-11 > > > Line search: gnorm after quadratic fit 2.752539686422e+05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.237188995536e+04 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.484370498858e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.571039994484e+03 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.280898858362e+02 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.708927009106e+02 lambda=2.6114913411793973e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.294919567784e+02 lambda=2.6114913411793975e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.291645609810e+02 lambda=2.6114913411793977e-05 > > > Line search: Cubically determined step, current gnorm > 1.291635530596e+02 lambda=1.2278773895355162e-05 > > > 23 SNES Function norm 1.291635530596e+02 > > > 0 KSP Residual norm 7.569206058965e+02 > > > 1 KSP Residual norm 3.454693729751e-11 > > > Line search: gnorm after quadratic fit 2.570888738395e+07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.064965025187e+06 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.498514098182e+05 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.807487005202e+04 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.233167830543e+03 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.396736912757e+03 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.547572543330e+02 lambda=1.2623406091699435e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.335889024473e+02 lambda=1.8542137907683829e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.292059042479e+02 lambda=1.8542137907683831e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.291637618568e+02 lambda=1.8542137907683832e-06 > > > Line search: Cubically determined step, current gnorm > 1.291635210734e+02 lambda=4.9524172913414387e-07 > > > 24 SNES Function norm 1.291635210734e+02 > > > 0 KSP Residual norm 3.761913422861e+03 > > > 1 KSP Residual norm 6.181718776929e-10 > > > Line search: gnorm after quadratic fit 3.342370445037e+09 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.218326646111e+08 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.375128803204e+07 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.980626157021e+06 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 9.407418671219e+05 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.357321025399e+05 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.188948059047e+04 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.105117929713e+03 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 9.331054736818e+02 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.942479792843e+02 lambda=1.9412500272460620e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.436944624694e+02 lambda=6.4483223307578726e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.292972287211e+02 lambda=6.4483223307578726e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.291647778160e+02 lambda=6.4483223307578730e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.291635261433e+02 lambda=6.4483223307578730e-08 > > > Line search: Cubically determined step, current gnorm > 1.291635197798e+02 lambda=2.0042115918485846e-08 > > > 25 SNES Function norm 1.291635197798e+02 > > > 0 KSP Residual norm 1.874745766083e+04 > > > 1 KSP Residual norm 1.476978150334e-09 > > > Line search: gnorm after quadratic fit 4.089262111368e+11 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.101717203770e+10 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.352565940292e+09 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.879613196620e+08 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 9.698613558125e+07 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.175566265039e+07 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.382919964952e+06 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.545431975334e+05 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.713561369103e+04 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.031789308419e+03 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 9.205847020738e+02 lambda=9.7656250000000005e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.957203153158e+02 lambda=2.8132879163728503e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.297923302791e+02 lambda=2.8132879163728504e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.291698100579e+02 lambda=2.8132879163728504e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.291635794525e+02 lambda=2.8132879163728506e-08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.291635200489e+02 lambda=2.8132879163728508e-09 > > > Line search: Cubically determined step, current gnorm > 1.291635197275e+02 lambda=8.0832061492461345e-10 > > > 26 SNES Function norm 1.291635197275e+02 > > > 0 KSP Residual norm 9.248381077528e+04 > > > 1 KSP Residual norm 7.262307068447e-09 > > > Line search: gnorm after quadratic fit 4.920647210624e+13 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.153216818065e+12 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.697543960375e+11 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 9.637004379805e+10 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.208402653149e+10 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.519988135798e+09 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.923903214787e+08 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.465663001976e+07 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.238603967195e+06 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.459179143177e+05 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.676301042792e+04 lambda=9.7656250000000005e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.135808875752e+04 lambda=4.8828125000000003e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.275714918657e+03 lambda=2.4414062500000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.719037747616e+02 lambda=1.2207031250000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.039826156716e+02 lambda=5.5609199181402721e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.308092967809e+02 lambda=9.1057337296683134e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.291796742824e+02 lambda=9.1057337296683134e-08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.291636800174e+02 lambda=9.1057337296683134e-09 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.291635212255e+02 lambda=9.1057337296683134e-10 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.291635197320e+02 lambda=9.1057337296683139e-11 > > > Line search: Cubically determined step, current gnorm > 1.291635197254e+02 lambda=3.2898162617097329e-11 > > > 27 SNES Function norm 1.291635197254e+02 > > > 0 KSP Residual norm 4.818745996826e+05 > > > 1 KSP Residual norm 3.300979345194e-08 > > > Line search: gnorm after quadratic fit 6.957046028867e+15 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 8.695654311477e+14 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.086793500688e+14 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.358083744813e+13 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.696584801696e+12 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.118183549773e+11 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.641372080976e+10 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.285878535769e+09 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.068045470276e+08 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.988290932539e+07 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.001404304764e+06 lambda=9.7656250000000005e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.962234585736e+05 lambda=4.8828125000000003e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.648190078115e+04 lambda=2.4414062500000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 9.098288624714e+03 lambda=1.2207031250000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.025132922751e+03 lambda=6.1035156250000003e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.536770142392e+02 lambda=3.0517578125000002e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.529553964021e+02 lambda=6.6615844706846272e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.293970371303e+02 lambda=6.6615844706846277e-08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.291658631829e+02 lambda=6.6615844706846284e-09 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.291635430890e+02 lambda=6.6615844706846284e-10 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.291635199508e+02 lambda=6.6615844706846284e-11 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.291635197268e+02 lambda=6.6615844706846284e-12 > > > Line search: Cubically determined step, current gnorm > 1.291635197253e+02 lambda=1.2496728806533799e-12 > > > 28 SNES Function norm 1.291635197253e+02 > > > 0 KSP Residual norm 2.124622394867e+06 > > > 1 KSP Residual norm 2.766225333896e-07 > > > Line search: gnorm after quadratic fit 5.963587884154e+17 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.454611858824e+16 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 9.318582340500e+15 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.164902175749e+15 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.456326197371e+14 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.820904039469e+13 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.277371273495e+12 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.849819609184e+11 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.570050545145e+10 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.482064028328e+09 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.651631635063e+08 lambda=9.7656250000000005e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.188623828904e+07 lambda=4.8828125000000003e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 9.302868645305e+06 lambda=2.4414062500000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.245214424313e+06 lambda=1.2207031250000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.775004618570e+05 lambda=6.1035156250000003e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.810228834086e+04 lambda=3.0517578125000002e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.148910945566e+03 lambda=1.5258789062500001e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.133679879416e+03 lambda=7.6293945312500004e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.382468615011e+02 lambda=3.8146972656250002e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.519773483633e+02 lambda=1.4103864371136453e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.293690599792e+02 lambda=1.4103864371136454e-08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.291655645282e+02 lambda=1.4103864371136455e-09 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.291635401518e+02 lambda=1.4103864371136456e-10 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.291635199283e+02 lambda=1.4103864371136456e-11 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.291635197272e+02 lambda=1.4103864371136456e-12 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.291635197253e+02 lambda=1.4103864371136457e-13 > > > Line search: unable to find good step length! After 25 tries > > > Line search: fnorm=1.2916351972528861e+02, > gnorm=1.2916351972529532e+02, ynorm=2.1246218291095798e+06, > minlambda=9.9999999999999998e-13, lambda=1.4103864371136457e-13, initial > slope=-1.6683210999382733e+04 > > > 0 SNES Function norm 7.158176401507e+03 > > > 0 KSP Residual norm 7.545626598553e+02 > > > 1 KSP Residual norm 2.192822940623e-11 > > > Line search: gnorm after quadratic fit 6.003975664723e+07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.501930637484e+06 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 9.380142516806e+05 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.179837352860e+05 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.656902039419e+04 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.340091686120e+03 lambda=3.1250000000000002e-03 > > > Line search: Cubically determined step, current gnorm > 7.127478647243e+03 lambda=1.5625000000000001e-03 > > > 1 SNES Function norm 7.127478647243e+03 > > > 0 KSP Residual norm 3.139792512249e+01 > > > 1 KSP Residual norm 5.765552480238e-13 > > > Line search: gnorm after quadratic fit 7.131728282938e+03 > > > Line search: Cubically determined step, current gnorm > 6.730387269330e+03 lambda=5.0000000000000003e-02 > > > 2 SNES Function norm 6.730387269330e+03 > > > 0 KSP Residual norm 2.247436817553e+01 > > > 1 KSP Residual norm 4.129717651221e-13 > > > Line search: gnorm after quadratic fit 6.018304311910e+03 > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > 3 SNES Function norm 6.018304311910e+03 > > > 0 KSP Residual norm 1.605973421081e+01 > > > 1 KSP Residual norm 3.614891198134e-13 > > > Line search: gnorm after quadratic fit 5.394599276028e+03 > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > 4 SNES Function norm 5.394599276028e+03 > > > 0 KSP Residual norm 1.491002227850e+01 > > > 1 KSP Residual norm 5.905756964447e-13 > > > Line search: gnorm after quadratic fit 4.845108544722e+03 > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > 5 SNES Function norm 4.845108544722e+03 > > > 0 KSP Residual norm 1.562997766581e+02 > > > 1 KSP Residual norm 5.722461855805e-12 > > > Line search: gnorm after quadratic fit 1.663505509947e+05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.368547472010e+04 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.067825049920e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.852173464442e+03 lambda=1.2500000000000001e-02 > > > Line search: Cubically determined step, current gnorm > 4.819549937425e+03 lambda=6.2500000000000003e-03 > > > 6 SNES Function norm 4.819549937425e+03 > > > 0 KSP Residual norm 1.652787385042e+01 > > > 1 KSP Residual norm 7.774483442550e-13 > > > Line search: gnorm after quadratic fit 2.868840270198e+03 > > > Line search: Quadratically determined step, > lambda=3.9586658383856743e-01 > > > 7 SNES Function norm 2.868840270198e+03 > > > 0 KSP Residual norm 1.220061851091e+01 > > > 1 KSP Residual norm 4.785407437718e-13 > > > Line search: gnorm after quadratic fit 2.616720732407e+03 > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > 8 SNES Function norm 2.616720732407e+03 > > > 0 KSP Residual norm 2.884722153958e+01 > > > 1 KSP Residual norm 5.474553921306e-13 > > > Line search: gnorm after quadratic fit 3.025386805317e+03 > > > Line search: Cubically determined step, current gnorm > 2.572110173067e+03 lambda=5.0000000000000003e-02 > > > 9 SNES Function norm 2.572110173067e+03 > > > 0 KSP Residual norm 5.239447686736e+01 > > > 1 KSP Residual norm 1.006906008399e-12 > > > Line search: gnorm after quadratic fit 5.237562098046e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.722529781980e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm > 2.553072891461e+03 lambda=2.5000000000000001e-02 > > > 10 SNES Function norm 2.553072891461e+03 > > > 0 KSP Residual norm 6.511316788880e+00 > > > 1 KSP Residual norm 1.340296659008e-13 > > > Line search: gnorm after quadratic fit 2.299704119080e+03 > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > 11 SNES Function norm 2.299704119080e+03 > > > 0 KSP Residual norm 5.268131426587e+00 > > > 1 KSP Residual norm 1.017563310127e-13 > > > Line search: Using full step: fnorm 2.299704119080e+03 gnorm > 7.642690039388e+02 > > > 12 SNES Function norm 7.642690039388e+02 > > > 0 KSP Residual norm 1.467735721574e+01 > > > 1 KSP Residual norm 1.090242963543e-12 > > > Line search: gnorm after quadratic fit 1.042766084830e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.924803860137e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm > 7.581126971182e+02 lambda=1.8508848315139208e-02 > > > 13 SNES Function norm 7.581126971182e+02 > > > 0 KSP Residual norm 2.222609581896e+00 > > > 1 KSP Residual norm 5.661437314341e-14 > > > Line search: gnorm after quadratic fit 6.235337602260e+02 > > > Line search: Quadratically determined step, > lambda=2.1172883827013136e-01 > > > 14 SNES Function norm 6.235337602260e+02 > > > 0 KSP Residual norm 3.080209609798e+00 > > > 1 KSP Residual norm 6.073476899313e-14 > > > Line search: gnorm after quadratic fit 5.704745248520e+02 > > > Line search: Quadratically determined step, > lambda=1.0142301129466913e-01 > > > 15 SNES Function norm 5.704745248520e+02 > > > 0 KSP Residual norm 5.628316803979e+00 > > > 1 KSP Residual norm 9.930477041779e-14 > > > Line search: gnorm after quadratic fit 5.401354794776e+02 > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > 16 SNES Function norm 5.401354794776e+02 > > > 0 KSP Residual norm 2.052541406719e+01 > > > 1 KSP Residual norm 4.328836834239e-13 > > > Line search: gnorm after quadratic fit 1.709850100987e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.717966555703e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.414032576976e+02 lambda=8.7805694170804971e-03 > > > Line search: Cubically determined step, current gnorm > 5.391967144330e+02 lambda=3.6341472475199424e-03 > > > 17 SNES Function norm 5.391967144330e+02 > > > 0 KSP Residual norm 2.246993769488e+00 > > > 1 KSP Residual norm 5.078373642913e-14 > > > Line search: gnorm after quadratic fit 4.939618639951e+02 > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > 18 SNES Function norm 4.939618639951e+02 > > > 0 KSP Residual norm 2.155867648564e+00 > > > 1 KSP Residual norm 4.438622106380e-14 > > > Line search: gnorm after quadratic fit 4.334377322188e+02 > > > Line search: Quadratically determined step, > lambda=1.5092486954829210e-01 > > > 19 SNES Function norm 4.334377322188e+02 > > > 0 KSP Residual norm 8.318284791610e+00 > > > 1 KSP Residual norm 6.910116607023e-13 > > > Line search: gnorm after quadratic fit 6.148799641401e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.502386288041e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm > 4.297879862602e+02 lambda=1.9565738732695813e-02 > > > 20 SNES Function norm 4.297879862602e+02 > > > 0 KSP Residual norm 7.593855254976e+01 > > > 1 KSP Residual norm 1.300639045149e-12 > > > Line search: gnorm after quadratic fit 7.318016560287e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.832525429452e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.543595712952e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.752901058720e+02 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.309726315570e+02 lambda=1.2500000000000002e-03 > > > Line search: Cubically determined step, current gnorm > 4.297464967378e+02 lambda=2.0986409143217158e-04 > > > 21 SNES Function norm 4.297464967378e+02 > > > 0 KSP Residual norm 8.492609701850e+00 > > > 1 KSP Residual norm 2.830329105288e-13 > > > Line search: gnorm after quadratic fit 6.575200413213e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.532760802544e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm > 4.268212296998e+02 lambda=1.8460064973695799e-02 > > > 22 SNES Function norm 4.268212296998e+02 > > > 0 KSP Residual norm 2.527155905469e+00 > > > 1 KSP Residual norm 2.235724978394e-13 > > > Line search: gnorm after quadratic fit 3.958132075117e+02 > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > 23 SNES Function norm 3.958132075117e+02 > > > 0 KSP Residual norm 3.425644398425e+00 > > > 1 KSP Residual norm 7.166017790799e-14 > > > Line search: gnorm after quadratic fit 3.803199338641e+02 > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > 24 SNES Function norm 3.803199338641e+02 > > > 0 KSP Residual norm 3.581435186688e+00 > > > 1 KSP Residual norm 1.730091027109e-13 > > > Line search: gnorm after quadratic fit 3.678433353709e+02 > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > 25 SNES Function norm 3.678433353709e+02 > > > 0 KSP Residual norm 2.817439291614e+00 > > > 1 KSP Residual norm 8.592333136485e-13 > > > Line search: gnorm after quadratic fit 3.472671313564e+02 > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > 26 SNES Function norm 3.472671313564e+02 > > > 0 KSP Residual norm 1.830066839089e+00 > > > 1 KSP Residual norm 3.248934231575e-14 > > > Line search: gnorm after quadratic fit 3.195079998571e+02 > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > 27 SNES Function norm 3.195079998571e+02 > > > 0 KSP Residual norm 3.775823654589e+00 > > > 1 KSP Residual norm 1.316233059492e-13 > > > Line search: gnorm after quadratic fit 3.252874639934e+02 > > > Line search: Cubically determined step, current gnorm > 3.125168318399e+02 lambda=5.0000000000000003e-02 > > > 28 SNES Function norm 3.125168318399e+02 > > > 0 KSP Residual norm 3.892613775622e+00 > > > 1 KSP Residual norm 7.093200713216e-11 > > > Line search: gnorm after quadratic fit 3.137590389484e+02 > > > Line search: Cubically determined step, current gnorm > 3.045559021319e+02 lambda=5.0000000000000003e-02 > > > 29 SNES Function norm 3.045559021319e+02 > > > 0 KSP Residual norm 2.364531179390e+00 > > > 1 KSP Residual norm 1.615423543115e-12 > > > Line search: gnorm after quadratic fit 2.864449141431e+02 > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > 30 SNES Function norm 2.864449141431e+02 > > > 0 KSP Residual norm 5.187063704081e+00 > > > 1 KSP Residual norm 4.254799504045e-13 > > > Line search: gnorm after quadratic fit 3.171238299438e+02 > > > Line search: Cubically determined step, current gnorm > 2.859321807369e+02 lambda=4.9550691080557742e-02 > > > 31 SNES Function norm 2.859321807369e+02 > > > 0 KSP Residual norm 2.400449127985e+01 > > > 1 KSP Residual norm 5.221032480453e-13 > > > Line search: gnorm after quadratic fit 1.812538817802e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.647888939229e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.905120335847e+02 lambda=7.3371687404129469e-03 > > > Line search: Cubically determined step, current gnorm > 2.857698450683e+02 lambda=1.3231746793531958e-03 > > > 32 SNES Function norm 2.857698450683e+02 > > > 0 KSP Residual norm 7.438521293559e+00 > > > 1 KSP Residual norm 1.293652874831e-12 > > > Line search: gnorm after quadratic fit 3.600694148787e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.932936811991e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm > 2.832774969882e+02 lambda=1.8636088141277370e-02 > > > 33 SNES Function norm 2.832774969882e+02 > > > 0 KSP Residual norm 2.676138557891e+00 > > > 1 KSP Residual norm 5.204105674042e-12 > > > Line search: gnorm after quadratic fit 2.698470565576e+02 > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > 34 SNES Function norm 2.698470565576e+02 > > > 0 KSP Residual norm 1.009562156863e+01 > > > 1 KSP Residual norm 3.544140587695e-13 > > > Line search: gnorm after quadratic fit 5.672695948559e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.197216154647e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm > 2.694068135292e+02 lambda=1.0762403784106927e-02 > > > 35 SNES Function norm 2.694068135292e+02 > > > 0 KSP Residual norm 3.927549314525e+00 > > > 1 KSP Residual norm 2.619134786598e-13 > > > Line search: gnorm after quadratic fit 2.646675787349e+02 > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > 36 SNES Function norm 2.646675787349e+02 > > > 0 KSP Residual norm 3.630219417922e+01 > > > 1 KSP Residual norm 1.546302717349e-12 > > > Line search: gnorm after quadratic fit 1.827432666108e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.342968941151e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 8.008633273369e+02 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.490753494196e+02 lambda=1.2345129233072847e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.682474011960e+02 lambda=3.3291959087019770e-03 > > > Line search: Cubically determined step, current gnorm > 2.646227701989e+02 lambda=4.0529212866107715e-04 > > > 37 SNES Function norm 2.646227701989e+02 > > > 0 KSP Residual norm 8.122774697994e+00 > > > 1 KSP Residual norm 1.316362046092e-13 > > > Line search: gnorm after quadratic fit 4.731092571363e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.030088374328e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm > 2.637462652877e+02 lambda=9.1057248517509397e-03 > > > 38 SNES Function norm 2.637462652877e+02 > > > 0 KSP Residual norm 2.601520363063e+00 > > > 1 KSP Residual norm 1.060764270007e-12 > > > Line search: gnorm after quadratic fit 2.536856446094e+02 > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > 39 SNES Function norm 2.536856446094e+02 > > > 0 KSP Residual norm 5.447955134327e+01 > > > 1 KSP Residual norm 2.556989975730e-12 > > > Line search: gnorm after quadratic fit 9.199250935618e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.998238940105e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.227083769291e+02 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.852215674478e+02 lambda=8.5024965111563117e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.537821339347e+02 lambda=8.5024965111563122e-04 > > > Line search: Cubically determined step, current gnorm > 2.536484146652e+02 lambda=2.9594242443314720e-04 > > > 40 SNES Function norm 2.536484146652e+02 > > > 0 KSP Residual norm 3.357359266965e+01 > > > 1 KSP Residual norm 8.485166742752e-11 > > > Line search: gnorm after quadratic fit 3.327150899857e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 8.660943990394e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.428891921377e+02 lambda=2.2262238648584176e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.550059920785e+02 lambda=3.9120439672600755e-03 > > > Line search: Cubically determined step, current gnorm > 2.535425543202e+02 lambda=8.8078244093807846e-04 > > > 41 SNES Function norm 2.535425543202e+02 > > > 0 KSP Residual norm 1.982789391732e+01 > > > 1 KSP Residual norm 1.156473750758e-11 > > > Line search: gnorm after quadratic fit 9.648483369708e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.023504841042e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.554919970151e+02 lambda=8.7092873850291869e-03 > > > Line search: Cubically determined step, current gnorm > 2.532490636747e+02 lambda=2.4564558988847251e-03 > > > 42 SNES Function norm 2.532490636747e+02 > > > 0 KSP Residual norm 1.762994613361e+01 > > > 1 KSP Residual norm 4.550684860593e-12 > > > Line search: gnorm after quadratic fit 6.772107527838e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.370541870778e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.532869639177e+02 lambda=7.7662700854918328e-03 > > > Line search: Cubically determined step, current gnorm > 2.527651129995e+02 lambda=3.8686733161537824e-03 > > > 43 SNES Function norm 2.527651129995e+02 > > > 0 KSP Residual norm 1.559278923951e+01 > > > 1 KSP Residual norm 1.060470887103e-11 > > > Line search: gnorm after quadratic fit 7.344361373020e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.498001534426e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.530518382567e+02 lambda=7.6730113050967469e-03 > > > Line search: Cubically determined step, current gnorm > 2.523423548732e+02 lambda=3.4156098513217236e-03 > > > 44 SNES Function norm 2.523423548732e+02 > > > 0 KSP Residual norm 1.190500639095e+01 > > > 1 KSP Residual norm 6.311739265577e-12 > > > Line search: gnorm after quadratic fit 4.875196633557e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.933215922947e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm > 2.516782376717e+02 lambda=9.8878729665301743e-03 > > > 45 SNES Function norm 2.516782376717e+02 > > > 0 KSP Residual norm 1.003632001309e+01 > > > 1 KSP Residual norm 7.039473047666e-13 > > > Line search: gnorm after quadratic fit 3.417133560813e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.636443273929e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm > 2.499729768042e+02 lambda=1.5332495922160540e-02 > > > 46 SNES Function norm 2.499729768042e+02 > > > 0 KSP Residual norm 5.252587112411e+01 > > > 1 KSP Residual norm 2.072629114336e-12 > > > Line search: gnorm after quadratic fit 7.891803681498e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.819076698717e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 5.911876424956e+02 lambda=2.4538865368827514e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.688195882303e+02 lambda=6.5764457912135515e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.500076295129e+02 lambda=6.5764457912135523e-04 > > > Line search: Cubically determined step, current gnorm > 2.499390700783e+02 lambda=2.7231956365922875e-04 > > > 47 SNES Function norm 2.499390700783e+02 > > > 0 KSP Residual norm 4.007648116930e+01 > > > 1 KSP Residual norm 5.646654234336e-11 > > > Line search: gnorm after quadratic fit 6.276152857499e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.418274035925e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.785345842563e+02 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.665412152699e+02 lambda=8.0607289886479045e-03 > > > Line search: Cubically determined step, current gnorm > 2.499109739904e+02 lambda=8.0607289886479045e-04 > > > 48 SNES Function norm 2.499109739904e+02 > > > 0 KSP Residual norm 1.339756751889e+01 > > > 1 KSP Residual norm 2.559175980945e-13 > > > Line search: gnorm after quadratic fit 6.052259901869e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm > 3.217431518450e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm > 2.496541765916e+02 lambda=7.0239599632283649e-03 > > > 49 SNES Function norm 2.496541765916e+02 > > > 0 KSP Residual norm 5.340771873687e+00 > > > 1 KSP Residual norm 1.207454778077e-13 > > > Line search: gnorm after quadratic fit 2.760767095070e+02 > > > Line search: Cubically determined step, current gnorm > 2.491630276458e+02 lambda=5.0000000000000003e-02 > > > 50 SNES Function norm 2.491630276458e+02 > > > > > > > > > On Sat, Aug 26, 2017 at 11:45 PM, Barry Smith > wrote: > > > > > > > On Aug 26, 2017, at 10:43 PM, zakaryah . wrote: > > > > > > > > Hi Barry - many thanks for taking the time to understand my many > problems and providing so much help. > > > > > > > > The reason I was concerned that I could not alter the linesearch was > when I tried to use bt instead of the L-BFGS default, cp, the code crashed > with an error like "Could not get Jacobian". Maybe this is an > incompatibility like you say, since L-BFGS only uses the initial Jacobian > and I never tried setting the scale type. > > > > > > > > I took your advice and tried to shrink the problem. First I tried > shrinking by a factor 1000 but this converged very quickly with all test > data I could provide, including the data which was problematic with the > large grid. So I settled for a reduction in size by a factor 125. The > grid size is 13,230. This is a decent test case because the solver fails > to converge with the options I was using before, and it is small enough > that I can run it with the options you suggested (-snes_fd_color -snes_type > newtonls -snes_monitor -snes_linesearch_monitor -ksp_monitor -pc_type lu). > > > > > > > > The output is 1800 lines long - how shall I share it? > > > > > > Just email it, that is small enough for email. > > > > > > Barry > > > > > > > > > > > > > > > > > > > > > > > On Sat, Aug 26, 2017 at 7:38 PM, Barry Smith > wrote: > > > > > > > > > On Aug 26, 2017, at 5:56 PM, zakaryah . > wrote: > > > > > > > > > > I'm using PETSc's SNES methods to solve PDEs which result from > Euler-Lagrange equations for the strain energy of a 3D displacement field. > There is an additional term in the Lagrangian which describes external > forces which arise from various data sets, and that term contains > nonlinearities (field terms higher than linear). The grid has about 1.6e6 > elements, and the displacement field has 3 components at each grid element. > > > > > > > > > > I'm trying to solve a sequence of successively more complicated > equations, and the latest equation is failing to converge on some data > sets. In particular, the methods were successful for the infinitesimal bulk > strain (compression) energy, as well as the full infinitesimal strain > energy (bulk + shear), but I'm now trying to generalize to the finite > strain, as certain data sets are known to result from displacement fields > for which the infinitesimal strain is a poor approximation. > > > > > > > > > > I'm using a DMDA, closely following example 48, and my preferred > solver is L-BFGS. > > > > > > > > So you are using ? > > > > > > > > -snes_type qn -snes_qn_type lbfgs > > > > > > > > > > > > > > I have read the FAQs "Why is Newton's method not converging??" and > "Why is my iterative linear solver not converging??"? which have raised a > number of questions: > > > > > > > > Quasi Newton methods either don't use Jacobians or use only the > initial Jacobian (the idea behind quasi-Newton methods is to approximate > Jacobian information from previous iterations without having the user > compute a Jacobian at each iteration). With PETSc's qn it only uses the > Jacobian if you use the option > > > > > > > > -snes_qn_scale_type Jacobian > > > > > > > > otherwise the Jacobian is never computed or used > > > > > > > > > > > > > > > > > > Is there documentation for the DMDA/SNES methods somewhere? I > don't understand these very well. For example, I am not allocating any > matrix for the global Jacobian, and I believe this prevents me from > changing the line search. If I'm mistaken I would love to see an example > of changing the line search type while using DMDA/SNES. > > > > > > > > Whether you provide a Jacobian or not is orthogonal to the line > search. > > > > > > > > You should be able to change the line search with > > > > > > > > -snes_linesearch_type bt or nleqerr or basic or l2 or cp > > > > > > > > not all of them may work with qn > > > > > > > > > > > > > > > > > > I don't know how to interpret the linesearch monitor. Even for > problems which are converging properly, the linesearch monitor reports > "lssucceed=0" on every iteration. Is this a problem? > > > > > > > > It returns a 0 if the line search does not believe it has achieved > "sufficient decrease" in the function norm (or possibly some other measure > of decrease) you should run -snes_linesearch_monitor also with the option > -snes_monitor to see what is happening to the function norm > > > > > > > > For qn you can add the option > > > > > > > > -snes_qn_monitor > > > > > > > > to get more detailed monitoring > > > > > > > > > > > > > > > > > > I'm also having trouble understanding the methods for > troubleshooting. I suspect that I've made an error in the analytical > Jacobian, which has a rather large number of non-zero elements, but I have > no idea how to use -snes_type test -snes_test_display. The FAQs mention > that some troubleshooting tools are more useful for small test problems. > How small is small? > > > > > > > > Tiny, at most a few dozen rows and columns in the Jacobin. > > > > > > > > You should run without the -snes_test_display information, what > does it say? Does it indicate the Jacobian or report there is likely a > problem? > > > > > > > > With DMDA you can also use -snes_fd_color to have PETSc compute > the Jacobian for you instead of using your analytical form. If it works > with this, but not your Jacobian then your Jacobian is wrong. > > > > > > > > > When I try to run the program with -snes_type test > -snes_test_display, I get errors like: > > > > > > > > > > [0]PETSC ERROR: Argument out of range [0]PETSC ERROR: Local index > 1076396032 too large 4979879 (max) at 0 > > > > > > > > > > The second size is 1 less than the number of field elements, while > the first number seems too large for any aspect of the problem - the > Jacobian has at most 59 non-zero columns per row. > > > > > > > > > > Because I suspect a possible error in the Jacobian, I ran with > -snes_mf_operator -pc_type ksp -ksp_ksp_rtol 1e-12 and observed very > similar failure to converge (diverging residual) as with the explicit > Jacobian. > > > > > > > > What do you get with -ksp_monitor -ksp_ksp_monitor it sounds > like the true Jacobian is either very ill-conditioned or your function > evaluation is wrong. > > > > > > > > > Do I need to set an SNES method which is somehow compatible with > the "matrix-free" approach? If I instead use -snes_mf, the problem seems to > converge, but horrendously slowly (true residual relative decrease by about > 1e-5 per iteration). I suppose this supports my suspicion that the > Jacobian is incorrect but doesn't really suggest a solution. > > > > > > > > > > Is it possible that the analytical Jacobian is correct, but > somehow pathological, which causes the SNES to diverge? > > > > > > > > Yes > > > > > > > > > Neither the Jacobian nor the function have singularities. > > > > > > > > > > Thanks for any help you can provide! > > > > > > > > Try really hard to set up a small problem (like just use a very > coarse grid) to experiment with as you try to get convergence. Using a big > problem for debugging convergence is a recipe for pain. > > > > > > > > Also since you have a Jacobian I would start with -snes_fd_color > -snes_type ls -snes_monitor -snes_linesearch_monitor -ksp_monitor -pc_type > lu (not on a huge problem), what happens? Send the output > > > > > > > > Barry > > > > > > > > > > > > > > > > > > > > > > > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From zakaryah at gmail.com Sun Aug 27 12:54:52 2017 From: zakaryah at gmail.com (zakaryah .) Date: Sun, 27 Aug 2017 13:54:52 -0400 Subject: [petsc-users] A number of questions about DMDA with SNES and Quasi-Newton methods In-Reply-To: References: <020DAED9-AAAD-4741-976B-BB2EF6C79D3F@mcs.anl.gov> <5BF530F6-8D79-47E6-B2C5-B0702FF2AA59@mcs.anl.gov> <7EE84495-4346-4BFB-B9AD-BCAA3C722461@mcs.anl.gov> Message-ID: Is it suspicious that the KSP converges so quickly? I have no experience with how the solvers behave on such small grids. Also, I ran the code with -snes_type test on a very small grid (1530 elements). The simpler version of the PDE ran fine, and showed good agreement of the matrices. However, the more complicated version crashes with the following errors: Testing hand-coded Jacobian, if the ratio is O(1.e-8), the hand-coded Jacobian is probably correct. Run with -snes_test_display to show difference of hand-coded and finite difference Jacobian. [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- [0]PETSC ERROR: Argument out of range [0]PETSC ERROR: Inserting a new nonzero at (7,0) in the matrix [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. [0]PETSC ERROR: Petsc Release Version 3.7.3, Jul, 24, 2016 [0]PETSC ERROR: #1 MatSetValues_SeqAIJ() line 484 in /PETSc/build/petsc-3.7.3/src/mat/impls/aij/seq/aij.c [0]PETSC ERROR: #2 MatSetValues() line 1190 in /PETSc/build/petsc-3.7.3/src/mat/interface/matrix.c [0]PETSC ERROR: #3 MatSetValuesLocal() line 2053 in /PETSc/build/petsc-3.7.3/src/mat/interface/matrix.c [0]PETSC ERROR: #4 MatSetValuesStencil() line 1447 in /PETSc/build/petsc-3.7.3/src/mat/interface/matrix.c Does this indicate a bug in the Jacobian calculation? I don't think I set values outside of the stencil... On Sun, Aug 27, 2017 at 12:14 AM, zakaryah . wrote: > Sure - it was this: > > mpiexec -n 1 -snes_fd_color -snes_type newtonls > -snes_monitor -snes_linesearch_monitor -ksp_monitor -pc_type lu > > On Sun, Aug 27, 2017 at 12:11 AM, Barry Smith wrote: > >> >> > On Aug 26, 2017, at 10:55 PM, zakaryah . wrote: >> > >> > Yes, except I changed "-snes_type ls" to "-snes_type newtonls" because >> PETSc complained that ls wasn't a known method. >> >> Sorry, my memory is not as good as it used to be; but what other >> options did you use? Send the exact command line. >> >> >> Barry >> ' >> > >> > On Sat, Aug 26, 2017 at 11:52 PM, Barry Smith >> wrote: >> > >> > My exact options did you run with? >> > >> > > On Aug 26, 2017, at 10:48 PM, zakaryah . wrote: >> > > >> > > Here's the output, from the data set which does not converge with >> l-bfgs: >> > > >> > > 0 SNES Function norm 1.370293318432e+04 >> > > 0 KSP Residual norm 7.457506389218e+02 >> > > 1 KSP Residual norm 2.244764079994e-10 >> > > Line search: gnorm after quadratic fit 6.541298279196e+05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 8.963717927372e+04 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.788909416707e+04 lambda=2.5000000000000001e-02 >> > > Line search: Cubically determined step, current gnorm >> 1.340565762719e+04 lambda=1.2500000000000001e-02 >> > > 1 SNES Function norm 1.340565762719e+04 >> > > 0 KSP Residual norm 4.096066553372e+02 >> > > 1 KSP Residual norm 3.313671167444e-11 >> > > Line search: gnorm after quadratic fit 1.113749573695e+06 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.406390140546e+05 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.126781917443e+04 lambda=2.5000000000000001e-02 >> > > Line search: Cubically determined step, current gnorm >> 1.272988597973e+04 lambda=1.2500000000000001e-02 >> > > 2 SNES Function norm 1.272988597973e+04 >> > > 0 KSP Residual norm 8.291344597817e+01 >> > > 1 KSP Residual norm 7.182258362182e-12 >> > > Line search: gnorm after quadratic fit 1.121913743889e+04 >> > > Line search: Quadratically determined step, >> lambda=1.0000000000000001e-01 >> > > 3 SNES Function norm 1.121913743889e+04 >> > > 0 KSP Residual norm 6.830535877014e+01 >> > > 1 KSP Residual norm 3.629826411580e-12 >> > > Line search: gnorm after quadratic fit 9.966344973786e+03 >> > > Line search: Quadratically determined step, >> lambda=1.0000000000000001e-01 >> > > 4 SNES Function norm 9.966344973786e+03 >> > > 0 KSP Residual norm 5.137691531345e+01 >> > > 1 KSP Residual norm 1.954502098181e-12 >> > > Line search: gnorm after quadratic fit 8.905508641232e+03 >> > > Line search: Quadratically determined step, >> lambda=1.0000000000000001e-01 >> > > 5 SNES Function norm 8.905508641232e+03 >> > > 0 KSP Residual norm 4.295019262963e+01 >> > > 1 KSP Residual norm 1.581527994925e-12 >> > > Line search: gnorm after quadratic fit 7.599173694189e+03 >> > > Line search: Quadratically determined step, >> lambda=1.4157226463489950e-01 >> > > 6 SNES Function norm 7.599173694189e+03 >> > > 0 KSP Residual norm 3.520472291520e+01 >> > > 1 KSP Residual norm 1.169994130568e-12 >> > > Line search: gnorm after quadratic fit 6.797214843928e+03 >> > > Line search: Quadratically determined step, >> lambda=1.0000000000000001e-01 >> > > 7 SNES Function norm 6.797214843928e+03 >> > > 0 KSP Residual norm 2.683523206056e+01 >> > > 1 KSP Residual norm 9.039858014119e-13 >> > > Line search: gnorm after quadratic fit 6.098038917364e+03 >> > > Line search: Quadratically determined step, >> lambda=1.0000000000000001e-01 >> > > 8 SNES Function norm 6.098038917364e+03 >> > > 0 KSP Residual norm 2.300710560681e+01 >> > > 1 KSP Residual norm 1.010402303464e-12 >> > > Line search: gnorm after quadratic fit 5.486151385552e+03 >> > > Line search: Quadratically determined step, >> lambda=1.0000000000000001e-01 >> > > 9 SNES Function norm 5.486151385552e+03 >> > > 0 KSP Residual norm 2.824628827619e+01 >> > > 1 KSP Residual norm 1.009589866569e-12 >> > > Line search: gnorm after quadratic fit 4.964991021247e+03 >> > > Line search: Quadratically determined step, >> lambda=1.0000000000000001e-01 >> > > 10 SNES Function norm 4.964991021247e+03 >> > > 0 KSP Residual norm 6.285926028595e+01 >> > > 1 KSP Residual norm 2.833546214180e-12 >> > > Line search: gnorm after quadratic fit 2.100041391472e+04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 5.804051080767e+03 lambda=5.0000000000000003e-02 >> > > Line search: Cubically determined step, current gnorm >> 4.893296169579e+03 lambda=2.5000000000000001e-02 >> > > 11 SNES Function norm 4.893296169579e+03 >> > > 0 KSP Residual norm 1.688978282804e+01 >> > > 1 KSP Residual norm 5.927677470786e-13 >> > > Line search: gnorm after quadratic fit 4.400894622431e+03 >> > > Line search: Quadratically determined step, >> lambda=1.0000000000000001e-01 >> > > 12 SNES Function norm 4.400894622431e+03 >> > > 0 KSP Residual norm 1.481197699600e+01 >> > > 1 KSP Residual norm 4.522572128105e-13 >> > > Line search: Using full step: fnorm 4.400894622431e+03 gnorm >> 2.094971849007e+03 >> > > 13 SNES Function norm 2.094971849007e+03 >> > > 0 KSP Residual norm 3.514164563318e+00 >> > > 1 KSP Residual norm 3.022385947499e-13 >> > > Line search: gnorm after quadratic fit 1.687641025382e+03 >> > > Line search: Quadratically determined step, >> lambda=2.0307116693368590e-01 >> > > 14 SNES Function norm 1.687641025382e+03 >> > > 0 KSP Residual norm 2.138591884686e+00 >> > > 1 KSP Residual norm 4.023500814078e-14 >> > > Line search: Using full step: fnorm 1.687641025382e+03 gnorm >> 1.131934218470e+03 >> > > 15 SNES Function norm 1.131934218470e+03 >> > > 0 KSP Residual norm 3.245035110327e+00 >> > > 1 KSP Residual norm 1.293626215269e-13 >> > > Line search: Using full step: fnorm 1.131934218470e+03 gnorm >> 7.340573607307e+02 >> > > 16 SNES Function norm 7.340573607307e+02 >> > > 0 KSP Residual norm 1.957698957904e+00 >> > > 1 KSP Residual norm 3.444648967078e-13 >> > > Line search: Using full step: fnorm 7.340573607307e+02 gnorm >> 5.024723505168e+02 >> > > 17 SNES Function norm 5.024723505168e+02 >> > > 0 KSP Residual norm 2.510538703839e+00 >> > > 1 KSP Residual norm 8.570440675253e-14 >> > > Line search: gnorm after quadratic fit 4.548776456608e+02 >> > > Line search: Quadratically determined step, >> lambda=1.0000000000000001e-01 >> > > 18 SNES Function norm 4.548776456608e+02 >> > > 0 KSP Residual norm 6.741705718178e-01 >> > > 1 KSP Residual norm 1.650556120809e-14 >> > > Line search: Using full step: fnorm 4.548776456608e+02 gnorm >> 1.351189086642e+02 >> > > 19 SNES Function norm 1.351189086642e+02 >> > > 0 KSP Residual norm 7.653741241950e+00 >> > > 1 KSP Residual norm 8.326848236950e-14 >> > > Line search: gnorm after quadratic fit 4.215455105006e+02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.889750369356e+02 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.358691836999e+02 lambda=1.0303015930243279e-02 >> > > Line search: Cubically determined step, current gnorm >> 1.348911963390e+02 lambda=3.5279526770504110e-03 >> > > 20 SNES Function norm 1.348911963390e+02 >> > > 0 KSP Residual norm 4.209281176918e+00 >> > > 1 KSP Residual norm 1.233232881375e-13 >> > > Line search: gnorm after quadratic fit 1.860023264470e+02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.413911132196e+02 lambda=5.0000000000000003e-02 >> > > Line search: Cubically determined step, current gnorm >> 1.339597869053e+02 lambda=1.5787957598629023e-02 >> > > 21 SNES Function norm 1.339597869053e+02 >> > > 0 KSP Residual norm 1.718484765841e+00 >> > > 1 KSP Residual norm 6.666016296543e-14 >> > > Line search: gnorm after quadratic fit 1.326878521472e+02 >> > > Line search: Quadratically determined step, >> lambda=1.0000000000000001e-01 >> > > 22 SNES Function norm 1.326878521472e+02 >> > > 0 KSP Residual norm 1.515373499919e+00 >> > > 1 KSP Residual norm 2.259154130795e-12 >> > > Line search: gnorm after quadratic fit 1.226907316391e+02 >> > > Line search: Quadratically determined step, >> lambda=1.0000000000000001e-01 >> > > 23 SNES Function norm 1.226907316391e+02 >> > > 0 KSP Residual norm 1.080252936903e+00 >> > > 1 KSP Residual norm 1.847020526683e-14 >> > > Line search: gnorm after quadratic fit 1.163632111851e+02 >> > > Line search: Quadratically determined step, >> lambda=1.0000000000000001e-01 >> > > 24 SNES Function norm 1.163632111851e+02 >> > > 0 KSP Residual norm 2.491746958382e+00 >> > > 1 KSP Residual norm 6.389134193637e-14 >> > > Line search: gnorm after quadratic fit 1.345487153563e+02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.169738363622e+02 lambda=4.4108900954515480e-02 >> > > Line search: Cubically determined step, current gnorm >> 1.152177638108e+02 lambda=1.9997442889243631e-02 >> > > 25 SNES Function norm 1.152177638108e+02 >> > > 0 KSP Residual norm 5.364385501004e+00 >> > > 1 KSP Residual norm 8.457149562463e-14 >> > > Line search: gnorm after quadratic fit 2.722095758964e+02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.480946353374e+02 lambda=5.0000000000000003e-02 >> > > Line search: Cubically determined step, current gnorm >> 1.150680255994e+02 lambda=6.3560128131639167e-03 >> > > 26 SNES Function norm 1.150680255994e+02 >> > > 0 KSP Residual norm 4.302025268263e+00 >> > > 1 KSP Residual norm 1.017526937941e-13 >> > > Line search: gnorm after quadratic fit 1.956300983573e+02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.318600522939e+02 lambda=5.0000000000000003e-02 >> > > Line search: Cubically determined step, current gnorm >> 1.147123505014e+02 lambda=7.6060788653548803e-03 >> > > 27 SNES Function norm 1.147123505014e+02 >> > > 0 KSP Residual norm 6.195463111324e+00 >> > > 1 KSP Residual norm 1.235283250361e-13 >> > > Line search: gnorm after quadratic fit 3.324821547049e+02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.612593208504e+02 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.147389525772e+02 lambda=6.1750939181374294e-03 >> > > Line search: Cubically determined step, current gnorm >> 1.145411432123e+02 lambda=3.0078592586792975e-03 >> > > 28 SNES Function norm 1.145411432123e+02 >> > > 0 KSP Residual norm 1.454704250187e+01 >> > > 1 KSP Residual norm 2.368485174123e-13 >> > > Line search: gnorm after quadratic fit 1.216293873116e+03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.796524621727e+02 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.359314163651e+02 lambda=1.4867675803955788e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.146009802557e+02 lambda=1.4867675803955788e-03 >> > > Line search: Cubically determined step, current gnorm >> 1.145096815033e+02 lambda=5.5250912472932839e-04 >> > > 29 SNES Function norm 1.145096815033e+02 >> > > 0 KSP Residual norm 3.430451345093e+01 >> > > 1 KSP Residual norm 1.069396165938e-12 >> > > Line search: gnorm after quadratic fit 1.161329407098e+04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.260690718050e+03 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 5.696806489042e+02 lambda=2.5000000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.960149915648e+02 lambda=1.1276129246469476e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.158113641658e+02 lambda=1.5873910451430554e-03 >> > > Line search: Cubically determined step, current gnorm >> 1.145062232916e+02 lambda=1.5873910451430555e-04 >> > > 30 SNES Function norm 1.145062232916e+02 >> > > 0 KSP Residual norm 2.662578971526e+01 >> > > 1 KSP Residual norm 5.464011789728e-13 >> > > Line search: gnorm after quadratic fit 4.375119254490e+03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.038018103928e+03 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.169328002874e+02 lambda=2.3789161387159519e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.262835432714e+02 lambda=5.9737415571960795e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.145626045197e+02 lambda=5.9737415571960802e-04 >> > > Line search: Cubically determined step, current gnorm >> 1.144968604079e+02 lambda=1.6421773527706333e-04 >> > > 31 SNES Function norm 1.144968604079e+02 >> > > 0 KSP Residual norm 6.322033697338e+01 >> > > 1 KSP Residual norm 1.507157991448e-12 >> > > Line search: gnorm after quadratic fit 5.809243699277e+04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 9.460487584142e+03 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.893183483197e+03 lambda=2.5000000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 4.960337007072e+02 lambda=1.2500000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.771527792790e+02 lambda=5.3912931685137378e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.150137639707e+02 lambda=5.3912931685137376e-04 >> > > Line search: Cubically determined step, current gnorm >> 1.144964484571e+02 lambda=5.3912931685137380e-05 >> > > 32 SNES Function norm 1.144964484571e+02 >> > > 0 KSP Residual norm 3.859510930996e+01 >> > > 1 KSP Residual norm 8.069118044382e-13 >> > > Line search: gnorm after quadratic fit 1.106329930525e+04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.155884463041e+03 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 5.933963819094e+02 lambda=2.5000000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.849629797377e+02 lambda=9.7744286136270241e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.150857687050e+02 lambda=9.7744286136270254e-04 >> > > Line search: Cubically determined step, current gnorm >> 1.144922906340e+02 lambda=9.7744286136270254e-05 >> > > 33 SNES Function norm 1.144922906340e+02 >> > > 0 KSP Residual norm 4.952038022394e+01 >> > > 1 KSP Residual norm 7.460263245424e-13 >> > > Line search: gnorm after quadratic fit 3.005091127220e+04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 5.229308416025e+03 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.138600794682e+03 lambda=2.5000000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.390856262238e+02 lambda=1.2500000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.394997214983e+02 lambda=4.4582997750629580e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.146836358799e+02 lambda=4.4582997750629581e-04 >> > > Line search: Cubically determined step, current gnorm >> 1.144895966587e+02 lambda=4.7644082443915877e-05 >> > > 34 SNES Function norm 1.144895966587e+02 >> > > 0 KSP Residual norm 1.146914786457e+02 >> > > 1 KSP Residual norm 4.791627042400e-12 >> > > Line search: gnorm after quadratic fit 2.601294145944e+05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.324148513778e+04 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 5.247478406023e+03 lambda=2.5000000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.200340900661e+03 lambda=1.2500000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.696223112300e+02 lambda=6.1514413845115794e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.342365431983e+02 lambda=1.7502929694284564e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.146686063035e+02 lambda=1.7502929694284566e-04 >> > > Line search: Cubically determined step, current gnorm >> 1.144895868489e+02 lambda=1.7502929694284566e-05 >> > > 35 SNES Function norm 1.144895868489e+02 >> > > 0 KSP Residual norm 6.311017209658e+01 >> > > 1 KSP Residual norm 8.384445939117e-13 >> > > Line search: gnorm after quadratic fit 5.781533400572e+04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 9.419557746031e+03 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.886081770030e+03 lambda=2.5000000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 4.945810143740e+02 lambda=1.2500000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.767820854837e+02 lambda=5.3859001959289735e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.150034040559e+02 lambda=5.3859001959289732e-04 >> > > Line search: Cubically determined step, current gnorm >> 1.144891501665e+02 lambda=5.3859001959289732e-05 >> > > 36 SNES Function norm 1.144891501665e+02 >> > > 0 KSP Residual norm 3.880748384332e+01 >> > > 1 KSP Residual norm 6.400339290453e-13 >> > > Line search: gnorm after quadratic fit 1.122504184426e+04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.180728237366e+03 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 5.987870621566e+02 lambda=2.5000000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.863711604331e+02 lambda=9.8150771384688824e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.150916783781e+02 lambda=9.8150771384688824e-04 >> > > Line search: Cubically determined step, current gnorm >> 1.144850837411e+02 lambda=9.8150771384688832e-05 >> > > 37 SNES Function norm 1.144850837411e+02 >> > > 0 KSP Residual norm 4.811537498557e+01 >> > > 1 KSP Residual norm 9.738167670242e-13 >> > > Line search: gnorm after quadratic fit 2.784098355218e+04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 4.885118868254e+03 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.074843354348e+03 lambda=2.5000000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.255202820836e+02 lambda=1.2500000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.365202996130e+02 lambda=4.3204204582016374e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.146504919412e+02 lambda=4.3204204582016374e-04 >> > > Line search: Cubically determined step, current gnorm >> 1.144822306241e+02 lambda=5.0376546850227848e-05 >> > > 38 SNES Function norm 1.144822306241e+02 >> > > 0 KSP Residual norm 1.120914002482e+02 >> > > 1 KSP Residual norm 5.452125292284e-12 >> > > Line search: gnorm after quadratic fit 2.427186680567e+05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.112196656857e+04 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 4.967397366072e+03 lambda=2.5000000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.149551659770e+03 lambda=1.2500000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.529630886791e+02 lambda=6.0885216927030559e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.315267519231e+02 lambda=1.6656233536183130e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.146353659250e+02 lambda=1.6656233536183130e-04 >> > > Line search: Cubically determined step, current gnorm >> 1.144820487391e+02 lambda=1.6656233536183130e-05 >> > > 39 SNES Function norm 1.144820487391e+02 >> > > 0 KSP Residual norm 7.182416170980e+01 >> > > 1 KSP Residual norm 1.292147133333e-12 >> > > Line search: gnorm after quadratic fit 8.255331293322e+04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.302939895170e+04 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.501228089911e+03 lambda=2.5000000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 6.185010378583e+02 lambda=1.2500000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.088179821424e+02 lambda=5.7489510178867142e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.168272901121e+02 lambda=9.7452649444612811e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.144951972300e+02 lambda=9.7452649444612822e-05 >> > > Line search: Cubically determined step, current gnorm >> 1.144807676687e+02 lambda=2.2399506502463798e-05 >> > > 40 SNES Function norm 1.144807676687e+02 >> > > 0 KSP Residual norm 1.728679810285e+02 >> > > 1 KSP Residual norm 3.878068639716e-12 >> > > Line search: gnorm after quadratic fit 9.011020578535e+05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.111818830011e+05 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.504789858103e+04 lambda=2.5000000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.754312133162e+03 lambda=1.2500000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 7.212492111975e+02 lambda=6.2500000000000003e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.199969180537e+02 lambda=2.6424184504193135e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.154794639440e+02 lambda=2.6424184504193136e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.144880673342e+02 lambda=2.6424184504193136e-05 >> > > Line search: Cubically determined step, current gnorm >> 1.144805461570e+02 lambda=3.8712107591125690e-06 >> > > 41 SNES Function norm 1.144805461570e+02 >> > > 0 KSP Residual norm 4.162780846202e+02 >> > > 1 KSP Residual norm 1.732341544934e-11 >> > > Line search: gnorm after quadratic fit 1.355673864369e+07 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.747523002884e+06 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.342205048417e+05 lambda=2.5000000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.425635699680e+04 lambda=1.2500000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 5.882150659178e+03 lambda=6.2500000000000003e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.259664786336e+03 lambda=3.1250000000000002e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.653670676209e+02 lambda=1.5625000000000001e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.453655830144e+02 lambda=5.8237455565260388e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.147659525018e+02 lambda=5.8237455565260393e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.144827915995e+02 lambda=5.8237455565260400e-06 >> > > Line search: Cubically determined step, current gnorm >> 1.144805080017e+02 lambda=6.6689295146509104e-07 >> > > 42 SNES Function norm 1.144805080017e+02 >> > > 0 KSP Residual norm 1.004135512581e+03 >> > > 1 KSP Residual norm 3.867626041000e-09 >> > > Line search: gnorm after quadratic fit 1.832578994882e+08 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.269698278878e+07 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.792476589915e+06 lambda=2.5000000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.420660371083e+05 lambda=1.2500000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 4.321686926168e+04 lambda=6.2500000000000003e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 6.548358078234e+03 lambda=3.1250000000000002e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.429504802276e+03 lambda=1.5625000000000001e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 4.317723385004e+02 lambda=7.8125000000000004e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.460079723095e+02 lambda=2.5078917343692407e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.147908977725e+02 lambda=2.5078917343692408e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.144833604238e+02 lambda=2.5078917343692412e-06 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.144805106824e+02 lambda=2.5078917343692411e-07 >> > > Line search: Cubically determined step, current gnorm >> 1.144805014337e+02 lambda=1.1468707119027746e-07 >> > > 43 SNES Function norm 1.144805014337e+02 >> > > 0 KSP Residual norm 2.418614573592e+03 >> > > 1 KSP Residual norm 6.085078742847e-10 >> > > Line search: gnorm after quadratic fit 2.598476259775e+09 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.262759415873e+08 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 4.116845970403e+07 lambda=2.5000000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 5.250465130250e+06 lambda=1.2500000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 6.863493884574e+05 lambda=6.2500000000000003e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 9.501468163771e+04 lambda=3.1250000000000002e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.482658980483e+04 lambda=1.5625000000000001e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.802395557883e+03 lambda=7.8125000000000004e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 6.788149582374e+02 lambda=3.9062500000000002e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.248828337038e+02 lambda=1.8333058767960295e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.186285836222e+02 lambda=3.7550993478654105e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.145209710139e+02 lambda=3.7550993478654107e-06 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.144808670668e+02 lambda=3.7550993478654111e-07 >> > > Line search: Cubically determined step, current gnorm >> 1.144805012252e+02 lambda=3.7550993478654114e-08 >> > > 44 SNES Function norm 1.144805012252e+02 >> > > 0 KSP Residual norm 1.432476672735e+03 >> > > 1 KSP Residual norm 7.850524783892e-11 >> > > Line search: gnorm after quadratic fit 5.336191593632e+08 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 6.625576866625e+07 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 8.181408387845e+06 lambda=2.5000000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.003310644422e+06 lambda=1.2500000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.236384273292e+05 lambda=6.2500000000000003e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.658430638069e+04 lambda=3.1250000000000002e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.977463068161e+03 lambda=1.5625000000000001e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 7.674238499253e+02 lambda=7.8125000000000004e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.333616820791e+02 lambda=3.3764776729281175e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.161349153752e+02 lambda=4.0497161764116874e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.144966925969e+02 lambda=4.0497161764116874e-06 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.144806214839e+02 lambda=4.0497161764116878e-07 >> > > Line search: Cubically determined step, current gnorm >> 1.144804979966e+02 lambda=5.6339112427782378e-08 >> > > 45 SNES Function norm 1.144804979966e+02 >> > > 0 KSP Residual norm 3.453401579761e+03 >> > > 1 KSP Residual norm 4.197968028126e-09 >> > > Line search: gnorm after quadratic fit 7.554006183767e+09 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 9.471974940372e+08 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.191613865049e+08 lambda=2.5000000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.509784334249e+07 lambda=1.2500000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.943752478560e+06 lambda=6.2500000000000003e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.597601716755e+05 lambda=3.1250000000000002e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.775572331075e+04 lambda=1.5625000000000001e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 6.418045407608e+03 lambda=7.8125000000000004e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.357066758731e+03 lambda=3.9062500000000002e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.859267839080e+02 lambda=1.9531250000000001e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.501494912160e+02 lambda=7.5160826909319168e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.148144926477e+02 lambda=7.5160826909319171e-06 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.144837498478e+02 lambda=7.5160826909319179e-07 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.144805227746e+02 lambda=7.5160826909319182e-08 >> > > Line search: Cubically determined step, current gnorm >> 1.144804974438e+02 lambda=9.6864021663644795e-09 >> > > 46 SNES Function norm 1.144804974438e+02 >> > > 0 KSP Residual norm 8.345139428850e+03 >> > > 1 KSP Residual norm 1.027819754739e-09 >> > > Line search: gnorm after quadratic fit 1.061319903906e+11 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.325012985379e+10 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.652236226640e+09 lambda=2.5000000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.055533971630e+08 lambda=1.2500000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.546607716763e+07 lambda=6.2500000000000003e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.134442858835e+06 lambda=3.1250000000000002e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.839168570687e+05 lambda=1.5625000000000001e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 4.830568178626e+04 lambda=7.8125000000000004e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 7.201776786081e+03 lambda=3.9062500000000002e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.540520468013e+03 lambda=1.9531250000000001e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 4.573504890506e+02 lambda=9.7656250000000005e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.516203908013e+02 lambda=3.2703670177372021e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.148480075676e+02 lambda=3.2703670177372022e-06 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.144841475328e+02 lambda=3.2703670177372023e-07 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.144805305720e+02 lambda=3.2703670177372021e-08 >> > > Line search: Cubically determined step, current gnorm >> 1.144804974367e+02 lambda=3.2703670177372025e-09 >> > > 47 SNES Function norm 1.144804974367e+02 >> > > 0 KSP Residual norm 4.668983500382e+03 >> > > 1 KSP Residual norm 1.398997665317e-09 >> > > Line search: gnorm after quadratic fit 1.865309565532e+10 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.336975299727e+09 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.934905088739e+08 lambda=2.5000000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.704520478641e+07 lambda=1.2500000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 4.728477809448e+06 lambda=6.2500000000000003e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 6.193001670096e+05 lambda=3.1250000000000002e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 8.610673238239e+04 lambda=1.5625000000000001e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.354711683605e+04 lambda=7.8125000000000004e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.589557246433e+03 lambda=3.9062500000000002e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 6.367851970709e+02 lambda=1.9531250000000001e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.136930269795e+02 lambda=9.0316845802227864e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.172186635069e+02 lambda=1.5831613287181393e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.145074017254e+02 lambda=1.5831613287181394e-06 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.144807499816e+02 lambda=1.5831613287181396e-07 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.144804983345e+02 lambda=1.5831613287181397e-08 >> > > Line search: Cubically determined step, current gnorm >> 1.144804971346e+02 lambda=5.2932921109871310e-09 >> > > 48 SNES Function norm 1.144804971346e+02 >> > > 0 KSP Residual norm 1.132678078317e+04 >> > > 1 KSP Residual norm 2.477518733314e-10 >> > > Line search: gnorm after quadratic fit 2.654659022365e+11 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.315296223725e+10 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 4.136635677074e+09 lambda=2.5000000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 5.152507060235e+08 lambda=1.2500000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 6.397060094478e+07 lambda=6.2500000000000003e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 7.898362012287e+06 lambda=3.1250000000000002e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 9.685179520906e+05 lambda=1.5625000000000001e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.194040779842e+05 lambda=7.8125000000000004e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.606415730227e+04 lambda=3.9062500000000002e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.902698091972e+03 lambda=1.9531250000000001e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 7.521549384652e+02 lambda=9.7656250000000005e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.288999778994e+02 lambda=4.1899746703195281e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.157880829786e+02 lambda=4.5470218451893824e-06 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.144935741206e+02 lambda=4.5470218451893828e-07 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.144806232638e+02 lambda=4.5470218451893831e-08 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.144804979250e+02 lambda=4.5470218451893835e-09 >> > > Line search: Cubically determined step, current gnorm >> 1.144804970825e+02 lambda=9.0293679903918216e-10 >> > > 49 SNES Function norm 1.144804970825e+02 >> > > 0 KSP Residual norm 2.712544829144e+04 >> > > 1 KSP Residual norm 4.949246309677e-09 >> > > Line search: gnorm after quadratic fit 3.650846005745e+12 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 4.565321055911e+11 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 5.711080201118e+10 lambda=2.5000000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 7.150022242308e+09 lambda=1.2500000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 8.965954117985e+08 lambda=6.2500000000000003e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.128096393645e+08 lambda=3.1250000000000002e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.429702091584e+07 lambda=1.5625000000000001e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.841819946536e+06 lambda=7.8125000000000004e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.465032956946e+05 lambda=3.9062500000000002e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.594210253794e+04 lambda=1.9531250000000001e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 6.141110278944e+03 lambda=9.7656250000000005e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.306952279045e+03 lambda=4.8828125000000003e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.754164864338e+02 lambda=2.4414062500000001e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.476861367158e+02 lambda=9.2451761406722810e-06 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.147929263780e+02 lambda=9.2451761406722810e-07 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.144836022952e+02 lambda=9.2451761406722821e-08 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.144805271860e+02 lambda=9.2451761406722831e-09 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.144804972895e+02 lambda=9.2451761406722839e-10 >> > > Line search: Cubically determined step, current gnorm >> 1.144804970737e+02 lambda=1.5633616333063305e-10 >> > > 50 SNES Function norm 1.144804970737e+02 >> > > 0 SNES Function norm 2.308693894796e+03 >> > > 0 KSP Residual norm 8.981999720532e+00 >> > > 1 KSP Residual norm 2.363170936183e-13 >> > > Line search: Using full step: fnorm 2.308693894796e+03 gnorm >> 7.571661187318e+02 >> > > 1 SNES Function norm 7.571661187318e+02 >> > > 0 KSP Residual norm 2.149614048903e+00 >> > > 1 KSP Residual norm 9.511247057888e-13 >> > > Line search: Using full step: fnorm 7.571661187318e+02 gnorm >> 4.450081004997e+02 >> > > 2 SNES Function norm 4.450081004997e+02 >> > > 0 KSP Residual norm 1.706469075123e+01 >> > > 1 KSP Residual norm 5.803815175472e-13 >> > > Line search: gnorm after quadratic fit 1.510518198899e+03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 5.850796532980e+02 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 4.515983139755e+02 lambda=2.0602556887689423e-02 >> > > Line search: Cubically determined step, current gnorm >> 4.434800867235e+02 lambda=8.2396279492937211e-03 >> > > 3 SNES Function norm 4.434800867235e+02 >> > > 0 KSP Residual norm 3.208587171626e+00 >> > > 1 KSP Residual norm 1.099072610659e-13 >> > > Line search: gnorm after quadratic fit 4.080637194736e+02 >> > > Line search: Quadratically determined step, >> lambda=1.0000000000000001e-01 >> > > 4 SNES Function norm 4.080637194736e+02 >> > > 0 KSP Residual norm 8.136557176540e+00 >> > > 1 KSP Residual norm 8.800137844173e-13 >> > > Line search: gnorm after quadratic fit 5.261656549654e+02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 4.131114070934e+02 lambda=5.0000000000000003e-02 >> > > Line search: Cubically determined step, current gnorm >> 4.031614746044e+02 lambda=2.4674842039461482e-02 >> > > 5 SNES Function norm 4.031614746044e+02 >> > > 0 KSP Residual norm 7.609918907567e+00 >> > > 1 KSP Residual norm 1.613159932655e-13 >> > > Line search: gnorm after quadratic fit 5.353908064984e+02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 4.110480554132e+02 lambda=5.0000000000000003e-02 >> > > Line search: Cubically determined step, current gnorm >> 3.991168240716e+02 lambda=2.3079500036735322e-02 >> > > 6 SNES Function norm 3.991168240716e+02 >> > > 0 KSP Residual norm 3.800845472041e+00 >> > > 1 KSP Residual norm 4.841682188278e-13 >> > > Line search: gnorm after quadratic fit 3.787886582952e+02 >> > > Line search: Quadratically determined step, >> lambda=1.0000000000000001e-01 >> > > 7 SNES Function norm 3.787886582952e+02 >> > > 0 KSP Residual norm 1.892621919219e+00 >> > > 1 KSP Residual norm 3.576655371800e-12 >> > > Line search: gnorm after quadratic fit 3.440181918909e+02 >> > > Line search: Quadratically determined step, >> lambda=1.0000000000000001e-01 >> > > 8 SNES Function norm 3.440181918909e+02 >> > > 0 KSP Residual norm 3.559759789147e+00 >> > > 1 KSP Residual norm 8.347521826622e-13 >> > > Line search: gnorm after quadratic fit 3.287993515195e+02 >> > > Line search: Quadratically determined step, >> lambda=1.0000000000000001e-01 >> > > 9 SNES Function norm 3.287993515195e+02 >> > > 0 KSP Residual norm 1.825073540507e+00 >> > > 1 KSP Residual norm 8.352745008123e-14 >> > > Line search: Using full step: fnorm 3.287993515195e+02 gnorm >> 2.710650507416e+02 >> > > 10 SNES Function norm 2.710650507416e+02 >> > > 0 KSP Residual norm 7.568432945608e-01 >> > > 1 KSP Residual norm 2.780715252274e-14 >> > > Line search: Using full step: fnorm 2.710650507416e+02 gnorm >> 1.513359047342e+02 >> > > 11 SNES Function norm 1.513359047342e+02 >> > > 0 KSP Residual norm 9.387460484575e+00 >> > > 1 KSP Residual norm 7.091233040676e-13 >> > > Line search: gnorm after quadratic fit 3.998857979851e+02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.060972049714e+02 lambda=5.0000000000000003e-02 >> > > Line search: Cubically determined step, current gnorm >> 1.512140169420e+02 lambda=5.4338709720680610e-03 >> > > 12 SNES Function norm 1.512140169420e+02 >> > > 0 KSP Residual norm 4.399424360499e+00 >> > > 1 KSP Residual norm 1.614362118182e-13 >> > > Line search: gnorm after quadratic fit 1.913552832643e+02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.559719302467e+02 lambda=5.0000000000000003e-02 >> > > Line search: Cubically determined step, current gnorm >> 1.499985374733e+02 lambda=1.7102027220313589e-02 >> > > 13 SNES Function norm 1.499985374733e+02 >> > > 0 KSP Residual norm 3.740397849742e+00 >> > > 1 KSP Residual norm 8.986775577006e-13 >> > > Line search: gnorm after quadratic fit 1.764118876632e+02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.522381536119e+02 lambda=4.8196830215713270e-02 >> > > Line search: Cubically determined step, current gnorm >> 1.486175880390e+02 lambda=1.8881300948189364e-02 >> > > 14 SNES Function norm 1.486175880390e+02 >> > > 0 KSP Residual norm 6.067973818528e+00 >> > > 1 KSP Residual norm 4.527845229549e-13 >> > > Line search: gnorm after quadratic fit 2.514021299115e+02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.679972156573e+02 lambda=5.0000000000000003e-02 >> > > Line search: Cubically determined step, current gnorm >> 1.481015724304e+02 lambda=9.0116621678703428e-03 >> > > 15 SNES Function norm 1.481015724304e+02 >> > > 0 KSP Residual norm 6.108754994263e+00 >> > > 1 KSP Residual norm 2.557635976440e-13 >> > > Line search: gnorm after quadratic fit 2.458081150104e+02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.681837029397e+02 lambda=5.0000000000000003e-02 >> > > Line search: Cubically determined step, current gnorm >> 1.476148340442e+02 lambda=7.9580911933571953e-03 >> > > 16 SNES Function norm 1.476148340442e+02 >> > > 0 KSP Residual norm 7.914946163932e+00 >> > > 1 KSP Residual norm 1.512066885699e-13 >> > > Line search: gnorm after quadratic fit 3.458938604598e+02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.883018868359e+02 lambda=5.0000000000000003e-02 >> > > Line search: Cubically determined step, current gnorm >> 1.474286108114e+02 lambda=6.7262521208543979e-03 >> > > 17 SNES Function norm 1.474286108114e+02 >> > > 0 KSP Residual norm 5.285449532689e+00 >> > > 1 KSP Residual norm 6.693733977456e-12 >> > > Line search: gnorm after quadratic fit 2.170263102661e+02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.607560548008e+02 lambda=5.0000000000000003e-02 >> > > Line search: Cubically determined step, current gnorm >> 1.467785507822e+02 lambda=9.9244383205188240e-03 >> > > 18 SNES Function norm 1.467785507822e+02 >> > > 0 KSP Residual norm 8.124903695635e+00 >> > > 1 KSP Residual norm 2.322439601127e-11 >> > > Line search: gnorm after quadratic fit 3.589716592364e+02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.907315184877e+02 lambda=5.0000000000000003e-02 >> > > Line search: Cubically determined step, current gnorm >> 1.466341888638e+02 lambda=6.5538271222582893e-03 >> > > 19 SNES Function norm 1.466341888638e+02 >> > > 0 KSP Residual norm 5.253550718343e+00 >> > > 1 KSP Residual norm 1.575657996883e-12 >> > > Line search: gnorm after quadratic fit 2.155795776725e+02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.598564001687e+02 lambda=5.0000000000000003e-02 >> > > Line search: Cubically determined step, current gnorm >> 1.459869404602e+02 lambda=9.9195822632931301e-03 >> > > 20 SNES Function norm 1.459869404602e+02 >> > > 0 KSP Residual norm 8.405987790193e+00 >> > > 1 KSP Residual norm 2.046159481178e-13 >> > > Line search: gnorm after quadratic fit 3.767908298426e+02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.941885062002e+02 lambda=5.0000000000000003e-02 >> > > Line search: Cubically determined step, current gnorm >> 1.458995232755e+02 lambda=6.4359684554015136e-03 >> > > 21 SNES Function norm 1.458995232755e+02 >> > > 0 KSP Residual norm 5.036348246593e+00 >> > > 1 KSP Residual norm 3.645081669075e-13 >> > > Line search: gnorm after quadratic fit 2.083222977519e+02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.575737508694e+02 lambda=5.0000000000000003e-02 >> > > Line search: Cubically determined step, current gnorm >> 1.452039802458e+02 lambda=1.0554092389542354e-02 >> > > 22 SNES Function norm 1.452039802458e+02 >> > > 0 KSP Residual norm 8.562292355998e+00 >> > > 1 KSP Residual norm 3.256332645483e-13 >> > > Line search: gnorm after quadratic fit 3.869470823355e+02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.959483128249e+02 lambda=5.0000000000000003e-02 >> > > Line search: Cubically determined step, current gnorm >> 1.451523830598e+02 lambda=6.3780526507799607e-03 >> > > 23 SNES Function norm 1.451523830598e+02 >> > > 0 KSP Residual norm 4.919667503862e+00 >> > > 1 KSP Residual norm 4.823931177115e-13 >> > > Line search: gnorm after quadratic fit 2.042891039525e+02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.560623102934e+02 lambda=5.0000000000000003e-02 >> > > Line search: Cubically determined step, current gnorm >> 1.444331916523e+02 lambda=1.0890355421223689e-02 >> > > 24 SNES Function norm 1.444331916523e+02 >> > > 0 KSP Residual norm 8.727282395369e+00 >> > > 1 KSP Residual norm 7.090683582186e-13 >> > > Line search: gnorm after quadratic fit 3.977929422821e+02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.978556223200e+02 lambda=5.0000000000000003e-02 >> > > Line search: Cubically determined step, current gnorm >> 1.444215965394e+02 lambda=6.3477766966048947e-03 >> > > 25 SNES Function norm 1.444215965394e+02 >> > > 0 KSP Residual norm 4.759732971179e+00 >> > > 1 KSP Residual norm 7.539889498211e-13 >> > > Line search: gnorm after quadratic fit 1.990589649135e+02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.542648241555e+02 lambda=5.0000000000000003e-02 >> > > Line search: Cubically determined step, current gnorm >> 1.436629416941e+02 lambda=1.1434720389464151e-02 >> > > 26 SNES Function norm 1.436629416941e+02 >> > > 0 KSP Residual norm 8.844861828477e+00 >> > > 1 KSP Residual norm 4.372001279689e-13 >> > > Line search: gnorm after quadratic fit 4.055598972133e+02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.990820671396e+02 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.436827663113e+02 lambda=6.3302081701296859e-03 >> > > Line search: Cubically determined step, current gnorm >> 1.434397789472e+02 lambda=3.1285674619640730e-03 >> > > 27 SNES Function norm 1.434397789472e+02 >> > > 0 KSP Residual norm 2.168630760128e+01 >> > > 1 KSP Residual norm 3.975838928402e-13 >> > > Line search: gnorm after quadratic fit 1.655681371309e+03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 4.972331169594e+02 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.804118272840e+02 lambda=1.6710557456633125e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.435928635079e+02 lambda=1.6710557456633126e-03 >> > > Line search: Cubically determined step, current gnorm >> 1.434032742903e+02 lambda=5.1357350159978810e-04 >> > > 28 SNES Function norm 1.434032742903e+02 >> > > 0 KSP Residual norm 5.259508821923e+01 >> > > 1 KSP Residual norm 1.358381204928e-11 >> > > Line search: gnorm after quadratic fit 1.908330224731e+04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.431279702545e+03 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 8.060945045253e+02 lambda=2.5000000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.791318323447e+02 lambda=1.2124172979783788e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.491140019897e+02 lambda=2.6952165802905347e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.434246250245e+02 lambda=2.6952165802905350e-04 >> > > Line search: Cubically determined step, current gnorm >> 1.433970449422e+02 lambda=8.6980371578986910e-05 >> > > 29 SNES Function norm 1.433970449422e+02 >> > > 0 KSP Residual norm 1.326287161615e+02 >> > > 1 KSP Residual norm 5.692176796134e-12 >> > > Line search: gnorm after quadratic fit 2.077891749832e+05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.654187989332e+04 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 4.213029457851e+03 lambda=2.5000000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.001385334742e+03 lambda=1.2500000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.323976827250e+02 lambda=5.9607661619885998e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.489839529892e+02 lambda=1.0476257410701045e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.434396736634e+02 lambda=1.0476257410701046e-04 >> > > Line search: Cubically determined step, current gnorm >> 1.433960671821e+02 lambda=1.3664867646895530e-05 >> > > 30 SNES Function norm 1.433960671821e+02 >> > > 0 KSP Residual norm 3.320710360189e+02 >> > > 1 KSP Residual norm 1.365660123102e-11 >> > > Line search: gnorm after quadratic fit 3.597335441013e+06 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 4.714766420450e+05 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 6.566809766217e+04 lambda=2.5000000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.038660363150e+04 lambda=1.2500000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.026997416957e+03 lambda=6.2500000000000003e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 5.382653551072e+02 lambda=3.1250000000000002e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.071747386385e+02 lambda=1.3384948046761360e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.439693866777e+02 lambda=1.3384948046761360e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.434000505249e+02 lambda=1.3384948046761361e-05 >> > > Line search: Cubically determined step, current gnorm >> 1.433959111179e+02 lambda=2.1771867000079373e-06 >> > > 31 SNES Function norm 1.433959111179e+02 >> > > 0 KSP Residual norm 8.385024273664e+02 >> > > 1 KSP Residual norm 2.688330817732e-11 >> > > Line search: gnorm after quadratic fit 5.487352481970e+07 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 6.776642694838e+06 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 8.310551423141e+05 lambda=2.5000000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.023322644608e+05 lambda=1.2500000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.368662233379e+04 lambda=6.2500000000000003e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.472194884015e+03 lambda=3.1250000000000002e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 6.718801059897e+02 lambda=1.5625000000000001e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.274234972424e+02 lambda=6.3064412238487922e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.442194384053e+02 lambda=6.3064412238487925e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.434033578642e+02 lambda=6.3064412238487927e-06 >> > > Line search: Cubically determined step, current gnorm >> 1.433959042208e+02 lambda=6.3064412238487929e-07 >> > > 32 SNES Function norm 1.433959042208e+02 >> > > 0 KSP Residual norm 5.310191626867e+02 >> > > 1 KSP Residual norm 2.270033897601e-10 >> > > Line search: gnorm after quadratic fit 1.447633783740e+07 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.859761774309e+06 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.472992503503e+05 lambda=2.5000000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.557594026810e+04 lambda=1.2500000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 5.969012939380e+03 lambda=6.2500000000000003e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.269212161982e+03 lambda=3.1250000000000002e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.859005100842e+02 lambda=1.5625000000000001e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.695095262046e+02 lambda=5.4509037994531233e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.436389958907e+02 lambda=5.4509037994531237e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.433976258223e+02 lambda=5.4509037994531242e-06 >> > > Line search: Cubically determined step, current gnorm >> 1.433958431980e+02 lambda=8.5124820362933632e-07 >> > > 33 SNES Function norm 1.433958431980e+02 >> > > 0 KSP Residual norm 1.341142541825e+03 >> > > 1 KSP Residual norm 4.194815344365e-11 >> > > Line search: gnorm after quadratic fit 2.256410317099e+08 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.797696259877e+07 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.447237377751e+06 lambda=2.5000000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 4.221898175722e+05 lambda=1.2500000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 5.260244723327e+04 lambda=6.2500000000000003e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 7.539148524881e+03 lambda=3.1250000000000002e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.558034531173e+03 lambda=1.5625000000000001e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 4.788188892302e+02 lambda=7.8125000000000004e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.753621043454e+02 lambda=2.4427125599600652e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.437122397600e+02 lambda=2.4427125599600654e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.433986985128e+02 lambda=2.4427125599600655e-06 >> > > Line search: Cubically determined step, current gnorm >> 1.433958402293e+02 lambda=2.4427125599600656e-07 >> > > 34 SNES Function norm 1.433958402293e+02 >> > > 0 KSP Residual norm 8.620962950418e+02 >> > > 1 KSP Residual norm 4.517777375659e-11 >> > > Line search: gnorm after quadratic fit 6.134442313460e+07 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 7.790495969255e+06 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.008365220843e+06 lambda=2.5000000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.364572513478e+05 lambda=1.2500000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.037891335918e+04 lambda=6.2500000000000003e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.640571521199e+03 lambda=3.1250000000000002e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 8.472549649319e+02 lambda=1.5625000000000001e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.906041216274e+02 lambda=7.6348458761785112e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.504925859329e+02 lambda=1.7740973415567094e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.434632637071e+02 lambda=1.7740973415567094e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.433962847027e+02 lambda=1.7740973415567095e-06 >> > > Line search: Cubically determined step, current gnorm >> 1.433958170795e+02 lambda=3.2293255704969003e-07 >> > > 35 SNES Function norm 1.433958170795e+02 >> > > 0 KSP Residual norm 2.177497039945e+03 >> > > 1 KSP Residual norm 8.546235181505e-11 >> > > Line search: gnorm after quadratic fit 9.689178330938e+08 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.204850731541e+08 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.491460480376e+07 lambda=2.5000000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.833699292784e+06 lambda=1.2500000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.246639021599e+05 lambda=6.2500000000000003e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.860166571872e+04 lambda=3.1250000000000002e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 4.484329051490e+03 lambda=1.5625000000000001e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.050411687443e+03 lambda=7.8125000000000004e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.488366972009e+02 lambda=3.7767265396089055e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.508326035050e+02 lambda=7.2725649346261757e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.434696063559e+02 lambda=7.2725649346261764e-06 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.433964618996e+02 lambda=7.2725649346261768e-07 >> > > Line search: Cubically determined step, current gnorm >> 1.433958141405e+02 lambda=7.2725649346261771e-08 >> > > 36 SNES Function norm 1.433958141405e+02 >> > > 0 KSP Residual norm 2.164813477994e+03 >> > > 1 KSP Residual norm 1.148881458292e-10 >> > > Line search: gnorm after quadratic fit 9.626940870744e+08 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.210459267934e+08 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.531855101756e+07 lambda=2.5000000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.966826097072e+06 lambda=1.2500000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.611808255272e+05 lambda=6.2500000000000003e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.746062783262e+04 lambda=3.1250000000000002e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 6.252259871244e+03 lambda=1.5625000000000001e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.319447372021e+03 lambda=7.8125000000000004e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.963055448218e+02 lambda=3.9062500000000002e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.719034797105e+02 lambda=1.3935000445038475e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.436664111092e+02 lambda=1.3935000445038476e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.433983336239e+02 lambda=1.3935000445038476e-06 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.433958213497e+02 lambda=1.3935000445038476e-07 >> > > Line search: Cubically determined step, current gnorm >> 1.433958104705e+02 lambda=5.1202466521517630e-08 >> > > 37 SNES Function norm 1.433958104705e+02 >> > > 0 KSP Residual norm 5.470482746849e+03 >> > > 1 KSP Residual norm 2.077456833170e-10 >> > > Line search: gnorm after quadratic fit 1.541335606193e+10 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.922526157954e+09 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.393079394383e+08 lambda=2.5000000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.967573549050e+07 lambda=1.2500000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.657319925168e+06 lambda=6.2500000000000003e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 4.479516204895e+05 lambda=3.1250000000000002e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 5.573399122917e+04 lambda=1.5625000000000001e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 7.931177424479e+03 lambda=7.8125000000000004e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.619710606187e+03 lambda=3.9062500000000002e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 4.924551713717e+02 lambda=1.9531250000000001e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.786095404459e+02 lambda=6.2808469554243522e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.437467476469e+02 lambda=6.2808469554243527e-06 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.433992463439e+02 lambda=6.2808469554243527e-07 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.433958367271e+02 lambda=6.2808469554243525e-08 >> > > Line search: Cubically determined step, current gnorm >> 1.433958098948e+02 lambda=8.0208105170108588e-09 >> > > 38 SNES Function norm 1.433958098948e+02 >> > > 0 KSP Residual norm 1.380568582849e+04 >> > > 1 KSP Residual norm 3.830866223513e-10 >> > > Line search: gnorm after quadratic fit 2.484973518314e+11 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.108953896984e+10 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.893104137528e+09 lambda=2.5000000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 4.884003910853e+08 lambda=1.2500000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 6.150765563542e+07 lambda=6.2500000000000003e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 7.811161146103e+06 lambda=3.1250000000000002e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.011017986781e+06 lambda=1.5625000000000001e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.368084343451e+05 lambda=7.8125000000000004e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.042876665700e+04 lambda=3.9062500000000002e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.648735196752e+03 lambda=1.9531250000000001e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 8.489051252413e+02 lambda=9.7656250000000005e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.910677756717e+02 lambda=4.7728537787817724e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.505452645186e+02 lambda=1.1099980464343249e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.434658984864e+02 lambda=1.1099980464343249e-06 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.433964956476e+02 lambda=1.1099980464343249e-07 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.433958153212e+02 lambda=1.1099980464343250e-08 >> > > Line search: Cubically determined step, current gnorm >> 1.433958098048e+02 lambda=1.2587012037197021e-09 >> > > 39 SNES Function norm 1.433958098048e+02 >> > > 0 KSP Residual norm 3.492284741552e+04 >> > > 1 KSP Residual norm 2.459788921244e-09 >> > > Line search: gnorm after quadratic fit 4.017424324975e+12 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 5.020053801097e+11 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 6.270768402853e+10 lambda=2.5000000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 7.827801904036e+09 lambda=1.2500000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 9.758550488105e+08 lambda=6.2500000000000003e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.213492627852e+08 lambda=3.1250000000000002e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.502191365805e+07 lambda=1.5625000000000001e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.846947104704e+06 lambda=7.8125000000000004e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.262850216093e+05 lambda=3.9062500000000002e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.879926646684e+04 lambda=1.9531250000000001e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 4.510203332079e+03 lambda=9.7656250000000005e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.055028679619e+03 lambda=4.8828125000000003e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.503903269554e+02 lambda=2.3633949212111800e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.510245991472e+02 lambda=4.5897967908360529e-06 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.434724062782e+02 lambda=4.5897967908360533e-07 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.433965706606e+02 lambda=4.5897967908360533e-08 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.433958168196e+02 lambda=4.5897967908360538e-09 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.433958098155e+02 lambda=4.5897967908360540e-10 >> > > Line search: Cubically determined step, current gnorm >> 1.433958097906e+02 lambda=1.9745369723997599e-10 >> > > 40 SNES Function norm 1.433958097906e+02 >> > > 0 KSP Residual norm 8.722495521587e+04 >> > > 1 KSP Residual norm 3.742695919275e-09 >> > > Line search: gnorm after quadratic fit 6.262538457180e+13 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 7.829256308992e+12 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 9.789282877890e+11 lambda=2.5000000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.224340679566e+11 lambda=1.2500000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.532137613500e+10 lambda=6.2500000000000003e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.919506047737e+09 lambda=3.1250000000000002e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.410488718338e+08 lambda=1.5625000000000001e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.042211373104e+07 lambda=7.8125000000000004e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.881986305609e+06 lambda=3.9062500000000002e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 5.080857001861e+05 lambda=1.9531250000000001e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 7.054449734307e+04 lambda=9.7656250000000005e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.109051581397e+04 lambda=4.8828125000000003e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.144985497099e+03 lambda=2.4414062500000001e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 5.617627947761e+02 lambda=1.2207031250000001e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.132828960986e+02 lambda=5.3137869181552773e-06 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.440403409760e+02 lambda=5.3137869181552777e-07 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.434022226216e+02 lambda=5.3137869181552781e-08 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.433958732177e+02 lambda=5.3137869181552781e-09 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.433958103569e+02 lambda=5.3137869181552779e-10 >> > > Line search: Cubically determined step, current gnorm >> 1.433958097894e+02 lambda=5.3137869181552781e-11 >> > > 41 SNES Function norm 1.433958097894e+02 >> > > 0 KSP Residual norm 6.453169081212e+04 >> > > 1 KSP Residual norm 2.762540688686e-09 >> > > Line search: gnorm after quadratic fit 2.535166112592e+13 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.168366990040e+12 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.958985371462e+11 lambda=2.5000000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 4.945064622488e+10 lambda=1.2500000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 6.172244865713e+09 lambda=6.2500000000000003e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 7.693002384290e+08 lambda=3.1250000000000002e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 9.562568994785e+07 lambda=1.5625000000000001e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.182957296890e+07 lambda=7.8125000000000004e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.453260254263e+06 lambda=3.9062500000000002e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.781984147743e+05 lambda=1.9531250000000001e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.294934468515e+04 lambda=9.7656250000000005e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.740461720782e+03 lambda=4.8828125000000003e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 9.162621855154e+02 lambda=2.4414062500000001e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.042417294890e+02 lambda=1.1290474210136388e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.458920680477e+02 lambda=1.4201366604660443e-06 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.434208620254e+02 lambda=1.4201366604660444e-07 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.433960586269e+02 lambda=1.4201366604660445e-08 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.433958120934e+02 lambda=1.4201366604660445e-09 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.433958097940e+02 lambda=1.4201366604660446e-10 >> > > Line search: Cubically determined step, current gnorm >> 1.433958097852e+02 lambda=5.7981795207229486e-11 >> > > 42 SNES Function norm 1.433958097852e+02 >> > > 0 KSP Residual norm 1.596625793747e+05 >> > > 1 KSP Residual norm 6.465899717071e-09 >> > > Line search: gnorm after quadratic fit 3.840699863976e+14 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 4.801237514773e+13 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 6.002454410823e+12 lambda=2.5000000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 7.505340831651e+11 lambda=1.2500000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 9.387378188418e+10 lambda=6.2500000000000003e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.174857842415e+10 lambda=3.1250000000000002e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.472211181784e+09 lambda=1.5625000000000001e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.849608933788e+08 lambda=7.8125000000000004e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.336592011613e+07 lambda=3.9062500000000002e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.988079805895e+06 lambda=1.9531250000000001e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.930858080425e+05 lambda=9.7656250000000005e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 5.521190722497e+04 lambda=4.8828125000000003e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 8.872153015323e+03 lambda=2.4414062500000001e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.772337662956e+03 lambda=1.2207031250000001e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 4.879470852054e+02 lambda=6.1035156250000003e-06 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.942774855488e+02 lambda=2.4957912736226801e-06 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.438719078958e+02 lambda=2.4957912736226800e-07 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.434005516391e+02 lambda=2.4957912736226800e-08 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.433958568732e+02 lambda=2.4957912736226803e-09 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.433958102244e+02 lambda=2.4957912736226804e-10 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.433958097865e+02 lambda=2.4957912736226805e-11 >> > > Line search: Cubically determined step, current gnorm >> 1.433958097846e+02 lambda=9.2900433293108317e-12 >> > > 43 SNES Function norm 1.433958097846e+02 >> > > 0 KSP Residual norm 4.230869747157e+05 >> > > 1 KSP Residual norm 2.238707423027e-08 >> > > Line search: gnorm after quadratic fit 7.145700515048e+15 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 8.931871281700e+14 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.116420341041e+14 lambda=2.5000000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.395366610168e+13 lambda=1.2500000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.743811756566e+12 lambda=6.2500000000000003e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.178776103292e+11 lambda=3.1250000000000002e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.721012032848e+10 lambda=1.5625000000000001e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.395186924428e+09 lambda=7.8125000000000004e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 4.229125978585e+08 lambda=3.9062500000000002e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 5.250971135953e+07 lambda=1.9531250000000001e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 6.483856203094e+06 lambda=9.7656250000000005e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 7.950671355228e+05 lambda=4.8828125000000003e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 9.795408218555e+04 lambda=2.4414062500000001e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.315025696280e+04 lambda=1.2207031250000001e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.395961070555e+03 lambda=6.1035156250000003e-06 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 6.565070307576e+02 lambda=3.0517578125000002e-06 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.228949713871e+02 lambda=1.2154989071946628e-06 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.441831998014e+02 lambda=1.2154989071946629e-07 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.434037055996e+02 lambda=1.2154989071946630e-08 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.433958886074e+02 lambda=1.2154989071946630e-09 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.433958105564e+02 lambda=1.2154989071946630e-10 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.433958097907e+02 lambda=1.2154989071946631e-11 >> > > Line search: Cubically determined step, current gnorm >> 1.433958097845e+02 lambda=1.3559489351735629e-12 >> > > 44 SNES Function norm 1.433958097845e+02 >> > > 0 KSP Residual norm 1.017589039922e+06 >> > > 1 KSP Residual norm 5.483283808994e-08 >> > > Line search: gnorm after quadratic fit 9.942386816509e+16 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.242813073279e+16 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.553553149772e+15 lambda=2.5000000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.942033483320e+14 lambda=1.2500000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.427772097758e+13 lambda=6.2500000000000003e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.035291372732e+12 lambda=3.1250000000000002e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.795558047824e+11 lambda=1.5625000000000001e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 4.748073147307e+10 lambda=7.8125000000000004e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 5.944235240368e+09 lambda=3.9062500000000002e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 7.453550734860e+08 lambda=1.9531250000000001e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 9.377045707707e+07 lambda=9.7656250000000005e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.188119937132e+07 lambda=4.8828125000000003e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.529730353136e+06 lambda=2.4414062500000001e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.044646611329e+05 lambda=1.2207031250000001e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.974477616118e+04 lambda=6.1035156250000003e-06 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 5.087923877078e+03 lambda=3.0517578125000002e-06 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.112257173311e+03 lambda=1.5258789062500001e-06 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.536190077033e+02 lambda=7.6293945312500004e-07 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.622567424729e+02 lambda=2.4244966960965791e-07 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.435780438142e+02 lambda=2.4244966960965793e-08 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.433976282603e+02 lambda=2.4244966960965796e-09 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.433958279382e+02 lambda=2.4244966960965797e-10 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.433958099632e+02 lambda=2.4244966960965799e-11 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.433958097860e+02 lambda=2.4244966960965801e-12 >> > > Line search: Cubically determined step, current gnorm >> 1.433958097845e+02 lambda=2.4244966960965801e-13 >> > > 45 SNES Function norm 1.433958097845e+02 >> > > 0 KSP Residual norm 2.206687220910e+06 >> > > 1 KSP Residual norm 4.897651438902e-08 >> > > Line search: gnorm after quadratic fit 1.013883843512e+18 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.267347883019e+17 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.584167551460e+16 lambda=2.5000000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.980166189110e+15 lambda=1.2500000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.475099638694e+14 lambda=6.2500000000000003e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.093604443378e+13 lambda=3.1250000000000002e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.866330988164e+12 lambda=1.5625000000000001e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 4.831230804145e+11 lambda=7.8125000000000004e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 6.034848618023e+10 lambda=3.9062500000000002e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 7.533173457427e+09 lambda=1.9531250000000001e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 9.390937545910e+08 lambda=9.7656250000000005e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.167706366282e+08 lambda=4.8828125000000003e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.445357932595e+07 lambda=2.4414062500000001e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.776833600920e+06 lambda=1.2207031250000001e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.177171496134e+05 lambda=6.1035156250000003e-06 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.775750596740e+04 lambda=3.0517578125000002e-06 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 4.374283858049e+03 lambda=1.5258789062500001e-06 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.030949543491e+03 lambda=7.6293945312500004e-07 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.423064811256e+02 lambda=3.6673216108643130e-07 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.499924205417e+02 lambda=6.7541706529544844e-08 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.434620968378e+02 lambda=6.7541706529544851e-09 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.433964732224e+02 lambda=6.7541706529544853e-10 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.433958164087e+02 lambda=6.7541706529544856e-11 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.433958098496e+02 lambda=6.7541706529544860e-12 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.433958097850e+02 lambda=6.7541706529544869e-13 >> > > Line search: unable to find good step length! After 24 tries >> > > Line search: fnorm=1.4339580978447020e+02, >> gnorm=1.4339580978501337e+02, ynorm=2.2066872446260620e+06, >> minlambda=9.9999999999999998e-13, lambda=6.7541706529544869e-13, initial >> slope=-2.0562359199040133e+04 >> > > 0 SNES Function norm 7.494832241120e+03 >> > > 0 KSP Residual norm 2.096735360816e+01 >> > > 1 KSP Residual norm 1.310027756820e-12 >> > > Line search: gnorm after quadratic fit 6.728375857515e+03 >> > > Line search: Quadratically determined step, >> lambda=1.0000000000000001e-01 >> > > 1 SNES Function norm 6.728375857515e+03 >> > > 0 KSP Residual norm 2.051806116405e+01 >> > > 1 KSP Residual norm 4.624620138831e-13 >> > > Line search: gnorm after quadratic fit 6.028616261650e+03 >> > > Line search: Quadratically determined step, >> lambda=1.0000000000000001e-01 >> > > 2 SNES Function norm 6.028616261650e+03 >> > > 0 KSP Residual norm 2.416503160016e+01 >> > > 1 KSP Residual norm 8.456041680630e-13 >> > > Line search: gnorm after quadratic fit 5.407473517447e+03 >> > > Line search: Quadratically determined step, >> lambda=1.0000000000000001e-01 >> > > 3 SNES Function norm 5.407473517447e+03 >> > > 0 KSP Residual norm 1.429873750399e+01 >> > > 1 KSP Residual norm 2.956316145819e-13 >> > > Line search: Using full step: fnorm 5.407473517447e+03 gnorm >> 1.894530516076e+03 >> > > 4 SNES Function norm 1.894530516076e+03 >> > > 0 KSP Residual norm 2.898580554597e+00 >> > > 1 KSP Residual norm 6.622560162623e-14 >> > > Line search: Using full step: fnorm 1.894530516076e+03 gnorm >> 1.794029421846e+03 >> > > 5 SNES Function norm 1.794029421846e+03 >> > > 0 KSP Residual norm 1.749678611959e+01 >> > > 1 KSP Residual norm 8.138905825078e-12 >> > > Line search: gnorm after quadratic fit 1.767361408940e+03 >> > > Line search: Quadratically determined step, >> lambda=1.0000000000000001e-01 >> > > 6 SNES Function norm 1.767361408940e+03 >> > > 0 KSP Residual norm 1.094404109423e+02 >> > > 1 KSP Residual norm 7.696691527700e-12 >> > > Line search: gnorm after quadratic fit 3.545750923895e+04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 6.153479540314e+03 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.205683629874e+03 lambda=2.5000000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.802976525485e+03 lambda=1.2441094586006883e-02 >> > > Line search: Cubically determined step, current gnorm >> 1.765063299263e+03 lambda=4.9240328094708914e-03 >> > > 7 SNES Function norm 1.765063299263e+03 >> > > 0 KSP Residual norm 1.778095975189e+01 >> > > 1 KSP Residual norm 2.814661813934e-12 >> > > Line search: gnorm after quadratic fit 2.620761680117e+03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.793045753271e+03 lambda=5.0000000000000003e-02 >> > > Line search: Cubically determined step, current gnorm >> 1.740299227935e+03 lambda=2.5000000000000001e-02 >> > > 8 SNES Function norm 1.740299227935e+03 >> > > 0 KSP Residual norm 3.284236894535e+02 >> > > 1 KSP Residual norm 5.172103783952e-10 >> > > Line search: gnorm after quadratic fit 2.857820523902e+05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 4.063993491139e+04 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 7.588139591650e+03 lambda=2.5000000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.491163684413e+03 lambda=1.2500000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.802614760566e+03 lambda=5.7977212395253904e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.741444490992e+03 lambda=1.8448315876950813e-03 >> > > Line search: Cubically determined step, current gnorm >> 1.739663656043e+03 lambda=7.7468345598227730e-04 >> > > 9 SNES Function norm 1.739663656043e+03 >> > > 0 KSP Residual norm 4.581839103558e+02 >> > > 1 KSP Residual norm 2.627035885943e-11 >> > > Line search: gnorm after quadratic fit 8.199478499066e+05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.127270076812e+05 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.816774161281e+04 lambda=2.5000000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 4.053723877333e+03 lambda=1.2500000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.971814513392e+03 lambda=6.2500000000000003e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.755066208174e+03 lambda=2.7232010924558834e-03 >> > > Line search: Cubically determined step, current gnorm >> 1.739559834479e+03 lambda=8.1458417855297680e-04 >> > > 10 SNES Function norm 1.739559834479e+03 >> > > 0 KSP Residual norm 1.463056810139e+02 >> > > 1 KSP Residual norm 5.383584598825e-12 >> > > Line search: gnorm after quadratic fit 2.885699620595e+04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 5.847717401708e+03 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.244464170034e+03 lambda=2.5000000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.769157604338e+03 lambda=1.0857209099577540e-02 >> > > Line search: Cubically determined step, current gnorm >> 1.737356225452e+03 lambda=4.0312937622950231e-03 >> > > 11 SNES Function norm 1.737356225452e+03 >> > > 0 KSP Residual norm 1.564105677925e+02 >> > > 1 KSP Residual norm 6.671164745832e-11 >> > > Line search: gnorm after quadratic fit 3.815800291873e+04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 7.197027796134e+03 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.373151605545e+03 lambda=2.5000000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.783976520867e+03 lambda=1.2093374970461970e-02 >> > > Line search: Cubically determined step, current gnorm >> 1.735737929915e+03 lambda=4.9529698477569920e-03 >> > > 12 SNES Function norm 1.735737929915e+03 >> > > 0 KSP Residual norm 5.030757139645e+01 >> > > 1 KSP Residual norm 1.157542730692e-12 >> > > Line search: gnorm after quadratic fit 3.004544441458e+03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.850403239750e+03 lambda=5.0000000000000003e-02 >> > > Line search: Cubically determined step, current gnorm >> 1.722893188305e+03 lambda=2.0881992439921702e-02 >> > > 13 SNES Function norm 1.722893188305e+03 >> > > 0 KSP Residual norm 7.123428853845e+01 >> > > 1 KSP Residual norm 8.671726774894e-12 >> > > Line search: gnorm after quadratic fit 4.361041499279e+03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.032697222107e+03 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.726212330814e+03 lambda=1.9909470348267504e-02 >> > > Line search: Cubically determined step, current gnorm >> 1.714127356920e+03 lambda=9.9547351741337518e-03 >> > > 14 SNES Function norm 1.714127356920e+03 >> > > 0 KSP Residual norm 8.304557447257e+00 >> > > 1 KSP Residual norm 6.268295862688e-13 >> > > Line search: gnorm after quadratic fit 1.558163002487e+03 >> > > Line search: Quadratically determined step, >> lambda=1.0000000000000001e-01 >> > > 15 SNES Function norm 1.558163002487e+03 >> > > 0 KSP Residual norm 2.820803287164e+00 >> > > 1 KSP Residual norm 5.477413853752e-13 >> > > Line search: gnorm after quadratic fit 1.065673478530e+03 >> > > Line search: Quadratically determined step, >> lambda=3.8943438938591052e-01 >> > > 16 SNES Function norm 1.065673478530e+03 >> > > 0 KSP Residual norm 2.296739120664e+00 >> > > 1 KSP Residual norm 6.273731899885e-14 >> > > Line search: gnorm after quadratic fit 8.964342150621e+02 >> > > Line search: Quadratically determined step, >> lambda=1.8740736900935545e-01 >> > > 17 SNES Function norm 8.964342150621e+02 >> > > 0 KSP Residual norm 5.567568505830e+00 >> > > 1 KSP Residual norm 8.649083600764e-12 >> > > Line search: gnorm after quadratic fit 8.322514858992e+02 >> > > Line search: Quadratically determined step, >> lambda=1.0000000000000001e-01 >> > > 18 SNES Function norm 8.322514858992e+02 >> > > 0 KSP Residual norm 1.164393577210e+00 >> > > 1 KSP Residual norm 2.019248309015e-14 >> > > Line search: Using full step: fnorm 8.322514858992e+02 gnorm >> 3.179750274746e+02 >> > > 19 SNES Function norm 3.179750274746e+02 >> > > 0 KSP Residual norm 5.339294310641e+00 >> > > 1 KSP Residual norm 2.070321587238e-13 >> > > Line search: gnorm after quadratic fit 3.433012316833e+02 >> > > Line search: Cubically determined step, current gnorm >> 3.140305403821e+02 lambda=5.0000000000000003e-02 >> > > 20 SNES Function norm 3.140305403821e+02 >> > > 0 KSP Residual norm 1.177016565578e+01 >> > > 1 KSP Residual norm 2.413027540446e-13 >> > > Line search: gnorm after quadratic fit 7.377851778409e+02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.896721016582e+02 lambda=5.0000000000000003e-02 >> > > Line search: Cubically determined step, current gnorm >> 3.136619309181e+02 lambda=9.7219892278716195e-03 >> > > 21 SNES Function norm 3.136619309181e+02 >> > > 0 KSP Residual norm 3.973565083977e+00 >> > > 1 KSP Residual norm 9.726786674410e-14 >> > > Line search: gnorm after quadratic fit 3.098277326090e+02 >> > > Line search: Quadratically determined step, >> lambda=1.0000000000000001e-01 >> > > 22 SNES Function norm 3.098277326090e+02 >> > > 0 KSP Residual norm 9.389290683519e+00 >> > > 1 KSP Residual norm 1.651497163724e-13 >> > > Line search: gnorm after quadratic fit 6.887970540455e+02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.588146381477e+02 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.099274823603e+02 lambda=1.6890426151283184e-02 >> > > Line search: Cubically determined step, current gnorm >> 3.084890760827e+02 lambda=8.4452130756415920e-03 >> > > 23 SNES Function norm 3.084890760827e+02 >> > > 0 KSP Residual norm 2.381130479641e+00 >> > > 1 KSP Residual norm 4.694489283156e-14 >> > > Line search: gnorm after quadratic fit 2.872151876535e+02 >> > > Line search: Quadratically determined step, >> lambda=1.0000000000000001e-01 >> > > 24 SNES Function norm 2.872151876535e+02 >> > > 0 KSP Residual norm 2.405498502269e+00 >> > > 1 KSP Residual norm 3.316846070538e-13 >> > > Line search: gnorm after quadratic fit 2.686789761232e+02 >> > > Line search: Quadratically determined step, >> lambda=1.0000000000000001e-01 >> > > 25 SNES Function norm 2.686789761232e+02 >> > > 0 KSP Residual norm 1.728772970554e+00 >> > > 1 KSP Residual norm 4.132974383339e-14 >> > > Line search: gnorm after quadratic fit 2.365009918229e+02 >> > > Line search: Quadratically determined step, >> lambda=1.7273357529379074e-01 >> > > 26 SNES Function norm 2.365009918229e+02 >> > > 0 KSP Residual norm 4.413764759374e+00 >> > > 1 KSP Residual norm 5.210690816917e-14 >> > > Line search: gnorm after quadratic fit 2.756730968257e+02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.372321757171e+02 lambda=5.0000000000000003e-02 >> > > Line search: Cubically determined step, current gnorm >> 2.335020811250e+02 lambda=2.5000000000000001e-02 >> > > 27 SNES Function norm 2.335020811250e+02 >> > > 0 KSP Residual norm 1.606246507553e+00 >> > > 1 KSP Residual norm 3.564847846678e-14 >> > > Line search: gnorm after quadratic fit 2.078263630653e+02 >> > > Line search: Quadratically determined step, >> lambda=1.5913860995949433e-01 >> > > 28 SNES Function norm 2.078263630653e+02 >> > > 0 KSP Residual norm 3.700632954873e+00 >> > > 1 KSP Residual norm 5.113863400264e-13 >> > > Line search: gnorm after quadratic fit 2.142503514807e+02 >> > > Line search: Cubically determined step, current gnorm >> 2.021095009118e+02 lambda=5.0000000000000003e-02 >> > > 29 SNES Function norm 2.021095009118e+02 >> > > 0 KSP Residual norm 3.056449560135e+00 >> > > 1 KSP Residual norm 3.207987681334e-14 >> > > Line search: gnorm after quadratic fit 2.064252530802e+02 >> > > Line search: Cubically determined step, current gnorm >> 1.978069081639e+02 lambda=5.0000000000000003e-02 >> > > 30 SNES Function norm 1.978069081639e+02 >> > > 0 KSP Residual norm 2.024695620703e+00 >> > > 1 KSP Residual norm 5.460360737995e-14 >> > > Line search: gnorm after quadratic fit 1.839556530796e+02 >> > > Line search: Quadratically determined step, >> lambda=1.0000000000000001e-01 >> > > 31 SNES Function norm 1.839556530796e+02 >> > > 0 KSP Residual norm 1.610676619931e+01 >> > > 1 KSP Residual norm 6.703552136307e-13 >> > > Line search: gnorm after quadratic fit 7.186735314913e+02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.905672430097e+02 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.856766286600e+02 lambda=1.0830798014298563e-02 >> > > Line search: Cubically determined step, current gnorm >> 1.836818937131e+02 lambda=3.3207362501459785e-03 >> > > 32 SNES Function norm 1.836818937131e+02 >> > > 0 KSP Residual norm 7.471722173131e+01 >> > > 1 KSP Residual norm 2.671534648829e-12 >> > > Line search: gnorm after quadratic fit 9.613379909411e+04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.509491298762e+04 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.808861367705e+03 lambda=2.5000000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 6.767283758299e+02 lambda=1.2500000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.665421328348e+02 lambda=6.0369453941238101e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.869726717041e+02 lambda=1.4394327006264963e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.836897704575e+02 lambda=1.4394327006264963e-04 >> > > Line search: Cubically determined step, current gnorm >> 1.836767951408e+02 lambda=5.5567420418543164e-05 >> > > 33 SNES Function norm 1.836767951408e+02 >> > > 0 KSP Residual norm 2.702367712138e+01 >> > > 1 KSP Residual norm 2.731656687850e-12 >> > > Line search: gnorm after quadratic fit 3.331563146098e+03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 8.723694790688e+02 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.941243220944e+02 lambda=2.1443568774664485e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.847231733910e+02 lambda=2.7571330376860012e-03 >> > > Line search: Cubically determined step, current gnorm >> 1.836356729409e+02 lambda=4.7841280418270480e-04 >> > > 34 SNES Function norm 1.836356729409e+02 >> > > 0 KSP Residual norm 1.228333177997e+01 >> > > 1 KSP Residual norm 2.681127387880e-13 >> > > Line search: gnorm after quadratic fit 6.936329223475e+02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.749327218775e+02 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.871557327742e+02 lambda=1.4160505301999991e-02 >> > > Line search: Cubically determined step, current gnorm >> 1.833523080682e+02 lambda=3.5196326548579192e-03 >> > > 35 SNES Function norm 1.833523080682e+02 >> > > 0 KSP Residual norm 3.531886257396e+02 >> > > 1 KSP Residual norm 2.364634092895e-11 >> > > Line search: gnorm after quadratic fit 3.994783047929e+06 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 4.753715960726e+05 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 5.516669898185e+04 lambda=2.5000000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 6.918985942348e+03 lambda=1.2500000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.363599250418e+03 lambda=6.2500000000000003e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 4.344906818752e+02 lambda=3.1250000000000002e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.991088183980e+02 lambda=1.0108094710462592e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.834621681844e+02 lambda=1.0108094710462593e-04 >> > > Line search: Cubically determined step, current gnorm >> 1.833517377324e+02 lambda=1.0108094710462594e-05 >> > > 36 SNES Function norm 1.833517377324e+02 >> > > 0 KSP Residual norm 9.005833507118e+01 >> > > 1 KSP Residual norm 6.116387880629e-12 >> > > Line search: gnorm after quadratic fit 8.899847103226e+04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.388111536526e+04 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.532652074749e+03 lambda=2.5000000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 5.864912734009e+02 lambda=1.2500000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.421068789960e+02 lambda=6.2500000000000003e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.873498120960e+02 lambda=2.1924025345283278e-03 >> > > Line search: Cubically determined step, current gnorm >> 1.833506987706e+02 lambda=2.1924025345283280e-04 >> > > 37 SNES Function norm 1.833506987706e+02 >> > > 0 KSP Residual norm 1.548426525207e+01 >> > > 1 KSP Residual norm 1.038038773942e-12 >> > > Line search: gnorm after quadratic fit 6.702848665441e+02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.789880616078e+02 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.846521504351e+02 lambda=1.0567302644323170e-02 >> > > Line search: Cubically determined step, current gnorm >> 1.830548481815e+02 lambda=3.5274490352771972e-03 >> > > 38 SNES Function norm 1.830548481815e+02 >> > > 0 KSP Residual norm 1.523095478807e+01 >> > > 1 KSP Residual norm 1.963823596119e-12 >> > > Line search: gnorm after quadratic fit 9.255727478491e+02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.496757253461e+02 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.863126241242e+02 lambda=9.3143291632966311e-03 >> > > Line search: Cubically determined step, current gnorm >> 1.829091761403e+02 lambda=1.8107234819462800e-03 >> > > 39 SNES Function norm 1.829091761403e+02 >> > > 0 KSP Residual norm 1.311320726934e+01 >> > > 1 KSP Residual norm 9.084170520902e-13 >> > > Line search: gnorm after quadratic fit 7.488610069188e+02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.691148243365e+02 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.885558228772e+02 lambda=1.9439894235886539e-02 >> > > Line search: Cubically determined step, current gnorm >> 1.825540619134e+02 lambda=5.4967824488704169e-03 >> > > 40 SNES Function norm 1.825540619134e+02 >> > > 0 KSP Residual norm 1.218635557505e+01 >> > > 1 KSP Residual norm 7.760485728617e-13 >> > > Line search: gnorm after quadratic fit 6.636453826807e+02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.880828006022e+02 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.830493790584e+02 lambda=6.6234802648049863e-03 >> > > Line search: Cubically determined step, current gnorm >> 1.823397545268e+02 lambda=2.4308217464828865e-03 >> > > 41 SNES Function norm 1.823397545268e+02 >> > > 0 KSP Residual norm 9.456543593865e+00 >> > > 1 KSP Residual norm 7.046593270309e-13 >> > > Line search: gnorm after quadratic fit 3.369769163110e+02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.105230957789e+02 lambda=5.0000000000000003e-02 >> > > Line search: Cubically determined step, current gnorm >> 1.817897533119e+02 lambda=9.1612481372917148e-03 >> > > 42 SNES Function norm 1.817897533119e+02 >> > > 0 KSP Residual norm 7.290035145805e+00 >> > > 1 KSP Residual norm 3.198962158141e-12 >> > > Line search: gnorm after quadratic fit 2.858311567415e+02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.965004842981e+02 lambda=5.0000000000000003e-02 >> > > Line search: Cubically determined step, current gnorm >> 1.808845577764e+02 lambda=1.3826421990147811e-02 >> > > 43 SNES Function norm 1.808845577764e+02 >> > > 0 KSP Residual norm 7.256785036157e+00 >> > > 1 KSP Residual norm 9.243179217625e-14 >> > > Line search: gnorm after quadratic fit 2.534388176390e+02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.916726818893e+02 lambda=5.0000000000000003e-02 >> > > Line search: Cubically determined step, current gnorm >> 1.797953125543e+02 lambda=1.3677747819164022e-02 >> > > 44 SNES Function norm 1.797953125543e+02 >> > > 0 KSP Residual norm 1.716201096352e+01 >> > > 1 KSP Residual norm 2.701418800808e-13 >> > > Line search: gnorm after quadratic fit 1.331064301474e+03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 4.461842246267e+02 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.920668830294e+02 lambda=1.2856504859057132e-02 >> > > Line search: Cubically determined step, current gnorm >> 1.797121460957e+02 lambda=1.4396611381500967e-03 >> > > 45 SNES Function norm 1.797121460957e+02 >> > > 0 KSP Residual norm 6.613432967985e+00 >> > > 1 KSP Residual norm 1.357752977076e-13 >> > > Line search: gnorm after quadratic fit 2.721288927858e+02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.939638282615e+02 lambda=5.0000000000000003e-02 >> > > Line search: Cubically determined step, current gnorm >> 1.787985482018e+02 lambda=1.2647907914070569e-02 >> > > 46 SNES Function norm 1.787985482018e+02 >> > > 0 KSP Residual norm 1.225736349281e+01 >> > > 1 KSP Residual norm 3.819378790812e-13 >> > > Line search: gnorm after quadratic fit 4.548006065036e+02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.304803559060e+02 lambda=5.0000000000000003e-02 >> > > Line search: Cubically determined step, current gnorm >> 1.787344729174e+02 lambda=8.9002284237256531e-03 >> > > 47 SNES Function norm 1.787344729174e+02 >> > > 0 KSP Residual norm 6.302465402340e+00 >> > > 1 KSP Residual norm 6.980931947122e-14 >> > > Line search: gnorm after quadratic fit 2.879477700004e+02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.980806946742e+02 lambda=5.0000000000000003e-02 >> > > Line search: Cubically determined step, current gnorm >> 1.780128006935e+02 lambda=1.0223293444602008e-02 >> > > 48 SNES Function norm 1.780128006935e+02 >> > > 0 KSP Residual norm 4.323829277968e+00 >> > > 1 KSP Residual norm 5.223881369308e-13 >> > > Line search: gnorm after quadratic fit 1.957928151218e+02 >> > > Line search: Cubically determined step, current gnorm >> 1.768899805640e+02 lambda=5.0000000000000003e-02 >> > > 49 SNES Function norm 1.768899805640e+02 >> > > 0 KSP Residual norm 2.249256107033e+00 >> > > 1 KSP Residual norm 3.624400957270e-14 >> > > Line search: gnorm after quadratic fit 1.704782114773e+02 >> > > Line search: Quadratically determined step, >> lambda=1.0000000000000001e-01 >> > > 50 SNES Function norm 1.704782114773e+02 >> > > 0 SNES Function norm 3.513783397332e+03 >> > > 0 KSP Residual norm 1.650214950648e+01 >> > > 1 KSP Residual norm 3.574269752690e-13 >> > > Line search: gnorm after quadratic fit 3.155830404050e+03 >> > > Line search: Quadratically determined step, >> lambda=1.0000000000000001e-01 >> > > 1 SNES Function norm 3.155830404050e+03 >> > > 0 KSP Residual norm 1.443734018042e+01 >> > > 1 KSP Residual norm 3.685565191058e-13 >> > > Line search: Using full step: fnorm 3.155830404050e+03 gnorm >> 8.581212204155e+02 >> > > 2 SNES Function norm 8.581212204155e+02 >> > > 0 KSP Residual norm 2.492601775565e+00 >> > > 1 KSP Residual norm 9.698440210389e-14 >> > > Line search: Using full step: fnorm 8.581212204155e+02 gnorm >> 7.018609898542e+02 >> > > 3 SNES Function norm 7.018609898542e+02 >> > > 0 KSP Residual norm 1.740320986421e+00 >> > > 1 KSP Residual norm 2.868780682435e-14 >> > > Line search: Using full step: fnorm 7.018609898542e+02 gnorm >> 2.135824235887e+02 >> > > 4 SNES Function norm 2.135824235887e+02 >> > > 0 KSP Residual norm 1.647413497077e+00 >> > > 1 KSP Residual norm 2.731226225666e-14 >> > > Line search: gnorm after quadratic fit 1.936469032649e+02 >> > > Line search: Quadratically determined step, >> lambda=1.0000000000000001e-01 >> > > 5 SNES Function norm 1.936469032649e+02 >> > > 0 KSP Residual norm 1.406615972124e+00 >> > > 1 KSP Residual norm 3.167179626699e-14 >> > > Line search: gnorm after quadratic fit 1.755362571467e+02 >> > > Line search: Quadratically determined step, >> lambda=1.0000000000000001e-01 >> > > 6 SNES Function norm 1.755362571467e+02 >> > > 0 KSP Residual norm 1.480681706594e+00 >> > > 1 KSP Residual norm 2.935210968935e-14 >> > > Line search: gnorm after quadratic fit 1.597659506616e+02 >> > > Line search: Quadratically determined step, >> lambda=1.0000000000000001e-01 >> > > 7 SNES Function norm 1.597659506616e+02 >> > > 0 KSP Residual norm 4.013154698097e+00 >> > > 1 KSP Residual norm 1.021628704832e-13 >> > > Line search: gnorm after quadratic fit 1.728408060966e+02 >> > > Line search: Cubically determined step, current gnorm >> 1.570815760721e+02 lambda=5.0000000000000003e-02 >> > > 8 SNES Function norm 1.570815760721e+02 >> > > 0 KSP Residual norm 1.510335662636e+00 >> > > 1 KSP Residual norm 2.728243244724e-14 >> > > Line search: gnorm after quadratic fit 1.450162880692e+02 >> > > Line search: Quadratically determined step, >> lambda=1.0000000000000001e-01 >> > > 9 SNES Function norm 1.450162880692e+02 >> > > 0 KSP Residual norm 1.923349271077e+01 >> > > 1 KSP Residual norm 1.640711956406e-11 >> > > Line search: gnorm after quadratic fit 1.016537223115e+03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.584263092048e+02 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.490729346583e+02 lambda=9.3725990358703350e-03 >> > > Line search: Cubically determined step, current gnorm >> 1.449349273006e+02 lambda=1.5464889706033082e-03 >> > > 10 SNES Function norm 1.449349273006e+02 >> > > 0 KSP Residual norm 1.154999084194e+01 >> > > 1 KSP Residual norm 1.292167633338e-11 >> > > Line search: gnorm after quadratic fit 6.060386918705e+02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.236630526035e+02 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.491201927819e+02 lambda=1.6816056300124185e-02 >> > > Line search: Cubically determined step, current gnorm >> 1.447023047013e+02 lambda=4.1484374564153808e-03 >> > > 11 SNES Function norm 1.447023047013e+02 >> > > 0 KSP Residual norm 7.278906180502e+00 >> > > 1 KSP Residual norm 2.815632651924e-12 >> > > Line search: gnorm after quadratic fit 2.512278711773e+02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.624350957814e+02 lambda=5.0000000000000003e-02 >> > > Line search: Cubically determined step, current gnorm >> 1.441656049510e+02 lambda=1.0879389002513012e-02 >> > > 12 SNES Function norm 1.441656049510e+02 >> > > 0 KSP Residual norm 4.449836480267e+00 >> > > 1 KSP Residual norm 3.152365624813e-13 >> > > Line search: gnorm after quadratic fit 1.749680739878e+02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.458763435996e+02 lambda=5.0000000000000003e-02 >> > > Line search: Cubically determined step, current gnorm >> 1.425715025152e+02 lambda=2.2766809271842225e-02 >> > > 13 SNES Function norm 1.425715025152e+02 >> > > 0 KSP Residual norm 4.218495037726e+00 >> > > 1 KSP Residual norm 1.398472536142e-12 >> > > Line search: gnorm after quadratic fit 1.645159536467e+02 >> > > Line search: Cubically determined step, current gnorm >> 1.421991559212e+02 lambda=4.1883769431247941e-02 >> > > 14 SNES Function norm 1.421991559212e+02 >> > > 0 KSP Residual norm 1.968853538608e+00 >> > > 1 KSP Residual norm 7.594023450519e-12 >> > > Line search: gnorm after quadratic fit 1.350960142124e+02 >> > > Line search: Quadratically determined step, >> lambda=1.0000000000000001e-01 >> > > 15 SNES Function norm 1.350960142124e+02 >> > > 0 KSP Residual norm 3.444721686085e+00 >> > > 1 KSP Residual norm 5.312609674019e-14 >> > > Line search: gnorm after quadratic fit 1.472880565107e+02 >> > > Line search: Cubically determined step, current gnorm >> 1.336714620145e+02 lambda=4.1341550820829437e-02 >> > > 16 SNES Function norm 1.336714620145e+02 >> > > 0 KSP Residual norm 3.276288899397e+00 >> > > 1 KSP Residual norm 8.394674946715e-14 >> > > Line search: gnorm after quadratic fit 1.459274497150e+02 >> > > Line search: Cubically determined step, current gnorm >> 1.327618539486e+02 lambda=5.0000000000000003e-02 >> > > 17 SNES Function norm 1.327618539486e+02 >> > > 0 KSP Residual norm 2.630052244303e+00 >> > > 1 KSP Residual norm 4.351283410507e-14 >> > > Line search: gnorm after quadratic fit 1.350378060116e+02 >> > > Line search: Cubically determined step, current gnorm >> 1.299403903934e+02 lambda=4.9913529436269283e-02 >> > > 18 SNES Function norm 1.299403903934e+02 >> > > 0 KSP Residual norm 6.124953430138e+00 >> > > 1 KSP Residual norm 2.295381352938e-13 >> > > Line search: gnorm after quadratic fit 2.275621676963e+02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.469611730657e+02 lambda=5.0000000000000003e-02 >> > > Line search: Cubically determined step, current gnorm >> 1.294890694898e+02 lambda=1.0071939100661648e-02 >> > > 19 SNES Function norm 1.294890694898e+02 >> > > 0 KSP Residual norm 1.036733907011e+01 >> > > 1 KSP Residual norm 1.800941381283e-13 >> > > Line search: gnorm after quadratic fit 3.844879463595e+02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.875071148504e+02 lambda=5.0000000000000003e-02 >> > > Line search: Cubically determined step, current gnorm >> 1.294494430642e+02 lambda=5.0000000000000010e-03 >> > > 20 SNES Function norm 1.294494430642e+02 >> > > 0 KSP Residual norm 8.224001595443e+00 >> > > 1 KSP Residual norm 3.337810156182e-13 >> > > Line search: gnorm after quadratic fit 3.332325263497e+02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.682441841234e+02 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.294720538860e+02 lambda=8.5401597581228530e-03 >> > > Line search: Cubically determined step, current gnorm >> 1.291762382985e+02 lambda=4.2555418164960989e-03 >> > > 21 SNES Function norm 1.291762382985e+02 >> > > 0 KSP Residual norm 3.920749219860e+01 >> > > 1 KSP Residual norm 1.610902886435e-12 >> > > Line search: gnorm after quadratic fit 3.472422440640e+03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.023065712859e+03 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.228184088700e+02 lambda=1.6004598823093592e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.298607525058e+02 lambda=1.6004598823093593e-03 >> > > Line search: Cubically determined step, current gnorm >> 1.291643460998e+02 lambda=1.9319076533745672e-04 >> > > 22 SNES Function norm 1.291643460998e+02 >> > > 0 KSP Residual norm 1.520092314848e+02 >> > > 1 KSP Residual norm 7.089159192434e-11 >> > > Line search: gnorm after quadratic fit 2.752539686422e+05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 4.237188995536e+04 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 7.484370498858e+03 lambda=2.5000000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.571039994484e+03 lambda=1.2500000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 4.280898858362e+02 lambda=6.2500000000000003e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.708927009106e+02 lambda=2.6114913411793973e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.294919567784e+02 lambda=2.6114913411793975e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.291645609810e+02 lambda=2.6114913411793977e-05 >> > > Line search: Cubically determined step, current gnorm >> 1.291635530596e+02 lambda=1.2278773895355162e-05 >> > > 23 SNES Function norm 1.291635530596e+02 >> > > 0 KSP Residual norm 7.569206058965e+02 >> > > 1 KSP Residual norm 3.454693729751e-11 >> > > Line search: gnorm after quadratic fit 2.570888738395e+07 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.064965025187e+06 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.498514098182e+05 lambda=2.5000000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.807487005202e+04 lambda=1.2500000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 5.233167830543e+03 lambda=6.2500000000000003e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.396736912757e+03 lambda=3.1250000000000002e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.547572543330e+02 lambda=1.2623406091699435e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.335889024473e+02 lambda=1.8542137907683829e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.292059042479e+02 lambda=1.8542137907683831e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.291637618568e+02 lambda=1.8542137907683832e-06 >> > > Line search: Cubically determined step, current gnorm >> 1.291635210734e+02 lambda=4.9524172913414387e-07 >> > > 24 SNES Function norm 1.291635210734e+02 >> > > 0 KSP Residual norm 3.761913422861e+03 >> > > 1 KSP Residual norm 6.181718776929e-10 >> > > Line search: gnorm after quadratic fit 3.342370445037e+09 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 4.218326646111e+08 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 5.375128803204e+07 lambda=2.5000000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 6.980626157021e+06 lambda=1.2500000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 9.407418671219e+05 lambda=6.2500000000000003e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.357321025399e+05 lambda=3.1250000000000002e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.188948059047e+04 lambda=1.5625000000000001e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 4.105117929713e+03 lambda=7.8125000000000004e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 9.331054736818e+02 lambda=3.9062500000000002e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.942479792843e+02 lambda=1.9412500272460620e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.436944624694e+02 lambda=6.4483223307578726e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.292972287211e+02 lambda=6.4483223307578726e-06 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.291647778160e+02 lambda=6.4483223307578730e-07 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.291635261433e+02 lambda=6.4483223307578730e-08 >> > > Line search: Cubically determined step, current gnorm >> 1.291635197798e+02 lambda=2.0042115918485846e-08 >> > > 25 SNES Function norm 1.291635197798e+02 >> > > 0 KSP Residual norm 1.874745766083e+04 >> > > 1 KSP Residual norm 1.476978150334e-09 >> > > Line search: gnorm after quadratic fit 4.089262111368e+11 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 5.101717203770e+10 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 6.352565940292e+09 lambda=2.5000000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 7.879613196620e+08 lambda=1.2500000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 9.698613558125e+07 lambda=6.2500000000000003e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.175566265039e+07 lambda=3.1250000000000002e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.382919964952e+06 lambda=1.5625000000000001e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.545431975334e+05 lambda=7.8125000000000004e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.713561369103e+04 lambda=3.9062500000000002e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.031789308419e+03 lambda=1.9531250000000001e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 9.205847020738e+02 lambda=9.7656250000000005e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.957203153158e+02 lambda=2.8132879163728503e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.297923302791e+02 lambda=2.8132879163728504e-06 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.291698100579e+02 lambda=2.8132879163728504e-07 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.291635794525e+02 lambda=2.8132879163728506e-08 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.291635200489e+02 lambda=2.8132879163728508e-09 >> > > Line search: Cubically determined step, current gnorm >> 1.291635197275e+02 lambda=8.0832061492461345e-10 >> > > 26 SNES Function norm 1.291635197275e+02 >> > > 0 KSP Residual norm 9.248381077528e+04 >> > > 1 KSP Residual norm 7.262307068447e-09 >> > > Line search: gnorm after quadratic fit 4.920647210624e+13 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 6.153216818065e+12 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 7.697543960375e+11 lambda=2.5000000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 9.637004379805e+10 lambda=1.2500000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.208402653149e+10 lambda=6.2500000000000003e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.519988135798e+09 lambda=3.1250000000000002e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.923903214787e+08 lambda=1.5625000000000001e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.465663001976e+07 lambda=7.8125000000000004e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.238603967195e+06 lambda=3.9062500000000002e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 4.459179143177e+05 lambda=1.9531250000000001e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 6.676301042792e+04 lambda=9.7656250000000005e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.135808875752e+04 lambda=4.8828125000000003e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.275714918657e+03 lambda=2.4414062500000001e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 5.719037747616e+02 lambda=1.2207031250000001e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.039826156716e+02 lambda=5.5609199181402721e-06 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.308092967809e+02 lambda=9.1057337296683134e-07 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.291796742824e+02 lambda=9.1057337296683134e-08 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.291636800174e+02 lambda=9.1057337296683134e-09 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.291635212255e+02 lambda=9.1057337296683134e-10 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.291635197320e+02 lambda=9.1057337296683139e-11 >> > > Line search: Cubically determined step, current gnorm >> 1.291635197254e+02 lambda=3.2898162617097329e-11 >> > > 27 SNES Function norm 1.291635197254e+02 >> > > 0 KSP Residual norm 4.818745996826e+05 >> > > 1 KSP Residual norm 3.300979345194e-08 >> > > Line search: gnorm after quadratic fit 6.957046028867e+15 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 8.695654311477e+14 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.086793500688e+14 lambda=2.5000000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.358083744813e+13 lambda=1.2500000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.696584801696e+12 lambda=6.2500000000000003e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.118183549773e+11 lambda=3.1250000000000002e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.641372080976e+10 lambda=1.5625000000000001e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.285878535769e+09 lambda=7.8125000000000004e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 4.068045470276e+08 lambda=3.9062500000000002e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 4.988290932539e+07 lambda=1.9531250000000001e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 6.001404304764e+06 lambda=9.7656250000000005e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 6.962234585736e+05 lambda=4.8828125000000003e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 7.648190078115e+04 lambda=2.4414062500000001e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 9.098288624714e+03 lambda=1.2207031250000001e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.025132922751e+03 lambda=6.1035156250000003e-06 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 6.536770142392e+02 lambda=3.0517578125000002e-06 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.529553964021e+02 lambda=6.6615844706846272e-07 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.293970371303e+02 lambda=6.6615844706846277e-08 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.291658631829e+02 lambda=6.6615844706846284e-09 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.291635430890e+02 lambda=6.6615844706846284e-10 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.291635199508e+02 lambda=6.6615844706846284e-11 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.291635197268e+02 lambda=6.6615844706846284e-12 >> > > Line search: Cubically determined step, current gnorm >> 1.291635197253e+02 lambda=1.2496728806533799e-12 >> > > 28 SNES Function norm 1.291635197253e+02 >> > > 0 KSP Residual norm 2.124622394867e+06 >> > > 1 KSP Residual norm 2.766225333896e-07 >> > > Line search: gnorm after quadratic fit 5.963587884154e+17 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 7.454611858824e+16 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 9.318582340500e+15 lambda=2.5000000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.164902175749e+15 lambda=1.2500000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.456326197371e+14 lambda=6.2500000000000003e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.820904039469e+13 lambda=3.1250000000000002e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.277371273495e+12 lambda=1.5625000000000001e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.849819609184e+11 lambda=7.8125000000000004e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.570050545145e+10 lambda=3.9062500000000002e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 4.482064028328e+09 lambda=1.9531250000000001e-04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 5.651631635063e+08 lambda=9.7656250000000005e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 7.188623828904e+07 lambda=4.8828125000000003e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 9.302868645305e+06 lambda=2.4414062500000001e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.245214424313e+06 lambda=1.2207031250000001e-05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.775004618570e+05 lambda=6.1035156250000003e-06 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.810228834086e+04 lambda=3.0517578125000002e-06 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 5.148910945566e+03 lambda=1.5258789062500001e-06 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.133679879416e+03 lambda=7.6293945312500004e-07 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.382468615011e+02 lambda=3.8146972656250002e-07 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.519773483633e+02 lambda=1.4103864371136453e-07 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.293690599792e+02 lambda=1.4103864371136454e-08 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.291655645282e+02 lambda=1.4103864371136455e-09 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.291635401518e+02 lambda=1.4103864371136456e-10 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.291635199283e+02 lambda=1.4103864371136456e-11 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.291635197272e+02 lambda=1.4103864371136456e-12 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.291635197253e+02 lambda=1.4103864371136457e-13 >> > > Line search: unable to find good step length! After 25 tries >> > > Line search: fnorm=1.2916351972528861e+02, >> gnorm=1.2916351972529532e+02, ynorm=2.1246218291095798e+06, >> minlambda=9.9999999999999998e-13, lambda=1.4103864371136457e-13, initial >> slope=-1.6683210999382733e+04 >> > > 0 SNES Function norm 7.158176401507e+03 >> > > 0 KSP Residual norm 7.545626598553e+02 >> > > 1 KSP Residual norm 2.192822940623e-11 >> > > Line search: gnorm after quadratic fit 6.003975664723e+07 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 7.501930637484e+06 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 9.380142516806e+05 lambda=2.5000000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.179837352860e+05 lambda=1.2500000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.656902039419e+04 lambda=6.2500000000000003e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 7.340091686120e+03 lambda=3.1250000000000002e-03 >> > > Line search: Cubically determined step, current gnorm >> 7.127478647243e+03 lambda=1.5625000000000001e-03 >> > > 1 SNES Function norm 7.127478647243e+03 >> > > 0 KSP Residual norm 3.139792512249e+01 >> > > 1 KSP Residual norm 5.765552480238e-13 >> > > Line search: gnorm after quadratic fit 7.131728282938e+03 >> > > Line search: Cubically determined step, current gnorm >> 6.730387269330e+03 lambda=5.0000000000000003e-02 >> > > 2 SNES Function norm 6.730387269330e+03 >> > > 0 KSP Residual norm 2.247436817553e+01 >> > > 1 KSP Residual norm 4.129717651221e-13 >> > > Line search: gnorm after quadratic fit 6.018304311910e+03 >> > > Line search: Quadratically determined step, >> lambda=1.0000000000000001e-01 >> > > 3 SNES Function norm 6.018304311910e+03 >> > > 0 KSP Residual norm 1.605973421081e+01 >> > > 1 KSP Residual norm 3.614891198134e-13 >> > > Line search: gnorm after quadratic fit 5.394599276028e+03 >> > > Line search: Quadratically determined step, >> lambda=1.0000000000000001e-01 >> > > 4 SNES Function norm 5.394599276028e+03 >> > > 0 KSP Residual norm 1.491002227850e+01 >> > > 1 KSP Residual norm 5.905756964447e-13 >> > > Line search: gnorm after quadratic fit 4.845108544722e+03 >> > > Line search: Quadratically determined step, >> lambda=1.0000000000000001e-01 >> > > 5 SNES Function norm 4.845108544722e+03 >> > > 0 KSP Residual norm 1.562997766581e+02 >> > > 1 KSP Residual norm 5.722461855805e-12 >> > > Line search: gnorm after quadratic fit 1.663505509947e+05 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.368547472010e+04 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 6.067825049920e+03 lambda=2.5000000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 4.852173464442e+03 lambda=1.2500000000000001e-02 >> > > Line search: Cubically determined step, current gnorm >> 4.819549937425e+03 lambda=6.2500000000000003e-03 >> > > 6 SNES Function norm 4.819549937425e+03 >> > > 0 KSP Residual norm 1.652787385042e+01 >> > > 1 KSP Residual norm 7.774483442550e-13 >> > > Line search: gnorm after quadratic fit 2.868840270198e+03 >> > > Line search: Quadratically determined step, >> lambda=3.9586658383856743e-01 >> > > 7 SNES Function norm 2.868840270198e+03 >> > > 0 KSP Residual norm 1.220061851091e+01 >> > > 1 KSP Residual norm 4.785407437718e-13 >> > > Line search: gnorm after quadratic fit 2.616720732407e+03 >> > > Line search: Quadratically determined step, >> lambda=1.0000000000000001e-01 >> > > 8 SNES Function norm 2.616720732407e+03 >> > > 0 KSP Residual norm 2.884722153958e+01 >> > > 1 KSP Residual norm 5.474553921306e-13 >> > > Line search: gnorm after quadratic fit 3.025386805317e+03 >> > > Line search: Cubically determined step, current gnorm >> 2.572110173067e+03 lambda=5.0000000000000003e-02 >> > > 9 SNES Function norm 2.572110173067e+03 >> > > 0 KSP Residual norm 5.239447686736e+01 >> > > 1 KSP Residual norm 1.006906008399e-12 >> > > Line search: gnorm after quadratic fit 5.237562098046e+03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.722529781980e+03 lambda=5.0000000000000003e-02 >> > > Line search: Cubically determined step, current gnorm >> 2.553072891461e+03 lambda=2.5000000000000001e-02 >> > > 10 SNES Function norm 2.553072891461e+03 >> > > 0 KSP Residual norm 6.511316788880e+00 >> > > 1 KSP Residual norm 1.340296659008e-13 >> > > Line search: gnorm after quadratic fit 2.299704119080e+03 >> > > Line search: Quadratically determined step, >> lambda=1.0000000000000001e-01 >> > > 11 SNES Function norm 2.299704119080e+03 >> > > 0 KSP Residual norm 5.268131426587e+00 >> > > 1 KSP Residual norm 1.017563310127e-13 >> > > Line search: Using full step: fnorm 2.299704119080e+03 gnorm >> 7.642690039388e+02 >> > > 12 SNES Function norm 7.642690039388e+02 >> > > 0 KSP Residual norm 1.467735721574e+01 >> > > 1 KSP Residual norm 1.090242963543e-12 >> > > Line search: gnorm after quadratic fit 1.042766084830e+03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 7.924803860137e+02 lambda=5.0000000000000003e-02 >> > > Line search: Cubically determined step, current gnorm >> 7.581126971182e+02 lambda=1.8508848315139208e-02 >> > > 13 SNES Function norm 7.581126971182e+02 >> > > 0 KSP Residual norm 2.222609581896e+00 >> > > 1 KSP Residual norm 5.661437314341e-14 >> > > Line search: gnorm after quadratic fit 6.235337602260e+02 >> > > Line search: Quadratically determined step, >> lambda=2.1172883827013136e-01 >> > > 14 SNES Function norm 6.235337602260e+02 >> > > 0 KSP Residual norm 3.080209609798e+00 >> > > 1 KSP Residual norm 6.073476899313e-14 >> > > Line search: gnorm after quadratic fit 5.704745248520e+02 >> > > Line search: Quadratically determined step, >> lambda=1.0142301129466913e-01 >> > > 15 SNES Function norm 5.704745248520e+02 >> > > 0 KSP Residual norm 5.628316803979e+00 >> > > 1 KSP Residual norm 9.930477041779e-14 >> > > Line search: gnorm after quadratic fit 5.401354794776e+02 >> > > Line search: Quadratically determined step, >> lambda=1.0000000000000001e-01 >> > > 16 SNES Function norm 5.401354794776e+02 >> > > 0 KSP Residual norm 2.052541406719e+01 >> > > 1 KSP Residual norm 4.328836834239e-13 >> > > Line search: gnorm after quadratic fit 1.709850100987e+03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 7.717966555703e+02 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 5.414032576976e+02 lambda=8.7805694170804971e-03 >> > > Line search: Cubically determined step, current gnorm >> 5.391967144330e+02 lambda=3.6341472475199424e-03 >> > > 17 SNES Function norm 5.391967144330e+02 >> > > 0 KSP Residual norm 2.246993769488e+00 >> > > 1 KSP Residual norm 5.078373642913e-14 >> > > Line search: gnorm after quadratic fit 4.939618639951e+02 >> > > Line search: Quadratically determined step, >> lambda=1.0000000000000001e-01 >> > > 18 SNES Function norm 4.939618639951e+02 >> > > 0 KSP Residual norm 2.155867648564e+00 >> > > 1 KSP Residual norm 4.438622106380e-14 >> > > Line search: gnorm after quadratic fit 4.334377322188e+02 >> > > Line search: Quadratically determined step, >> lambda=1.5092486954829210e-01 >> > > 19 SNES Function norm 4.334377322188e+02 >> > > 0 KSP Residual norm 8.318284791610e+00 >> > > 1 KSP Residual norm 6.910116607023e-13 >> > > Line search: gnorm after quadratic fit 6.148799641401e+02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 4.502386288041e+02 lambda=5.0000000000000003e-02 >> > > Line search: Cubically determined step, current gnorm >> 4.297879862602e+02 lambda=1.9565738732695813e-02 >> > > 20 SNES Function norm 4.297879862602e+02 >> > > 0 KSP Residual norm 7.593855254976e+01 >> > > 1 KSP Residual norm 1.300639045149e-12 >> > > Line search: gnorm after quadratic fit 7.318016560287e+04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 7.832525429452e+03 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.543595712952e+03 lambda=2.5000000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 6.752901058720e+02 lambda=1.2500000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 4.309726315570e+02 lambda=1.2500000000000002e-03 >> > > Line search: Cubically determined step, current gnorm >> 4.297464967378e+02 lambda=2.0986409143217158e-04 >> > > 21 SNES Function norm 4.297464967378e+02 >> > > 0 KSP Residual norm 8.492609701850e+00 >> > > 1 KSP Residual norm 2.830329105288e-13 >> > > Line search: gnorm after quadratic fit 6.575200413213e+02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 4.532760802544e+02 lambda=5.0000000000000003e-02 >> > > Line search: Cubically determined step, current gnorm >> 4.268212296998e+02 lambda=1.8460064973695799e-02 >> > > 22 SNES Function norm 4.268212296998e+02 >> > > 0 KSP Residual norm 2.527155905469e+00 >> > > 1 KSP Residual norm 2.235724978394e-13 >> > > Line search: gnorm after quadratic fit 3.958132075117e+02 >> > > Line search: Quadratically determined step, >> lambda=1.0000000000000001e-01 >> > > 23 SNES Function norm 3.958132075117e+02 >> > > 0 KSP Residual norm 3.425644398425e+00 >> > > 1 KSP Residual norm 7.166017790799e-14 >> > > Line search: gnorm after quadratic fit 3.803199338641e+02 >> > > Line search: Quadratically determined step, >> lambda=1.0000000000000001e-01 >> > > 24 SNES Function norm 3.803199338641e+02 >> > > 0 KSP Residual norm 3.581435186688e+00 >> > > 1 KSP Residual norm 1.730091027109e-13 >> > > Line search: gnorm after quadratic fit 3.678433353709e+02 >> > > Line search: Quadratically determined step, >> lambda=1.0000000000000001e-01 >> > > 25 SNES Function norm 3.678433353709e+02 >> > > 0 KSP Residual norm 2.817439291614e+00 >> > > 1 KSP Residual norm 8.592333136485e-13 >> > > Line search: gnorm after quadratic fit 3.472671313564e+02 >> > > Line search: Quadratically determined step, >> lambda=1.0000000000000001e-01 >> > > 26 SNES Function norm 3.472671313564e+02 >> > > 0 KSP Residual norm 1.830066839089e+00 >> > > 1 KSP Residual norm 3.248934231575e-14 >> > > Line search: gnorm after quadratic fit 3.195079998571e+02 >> > > Line search: Quadratically determined step, >> lambda=1.0000000000000001e-01 >> > > 27 SNES Function norm 3.195079998571e+02 >> > > 0 KSP Residual norm 3.775823654589e+00 >> > > 1 KSP Residual norm 1.316233059492e-13 >> > > Line search: gnorm after quadratic fit 3.252874639934e+02 >> > > Line search: Cubically determined step, current gnorm >> 3.125168318399e+02 lambda=5.0000000000000003e-02 >> > > 28 SNES Function norm 3.125168318399e+02 >> > > 0 KSP Residual norm 3.892613775622e+00 >> > > 1 KSP Residual norm 7.093200713216e-11 >> > > Line search: gnorm after quadratic fit 3.137590389484e+02 >> > > Line search: Cubically determined step, current gnorm >> 3.045559021319e+02 lambda=5.0000000000000003e-02 >> > > 29 SNES Function norm 3.045559021319e+02 >> > > 0 KSP Residual norm 2.364531179390e+00 >> > > 1 KSP Residual norm 1.615423543115e-12 >> > > Line search: gnorm after quadratic fit 2.864449141431e+02 >> > > Line search: Quadratically determined step, >> lambda=1.0000000000000001e-01 >> > > 30 SNES Function norm 2.864449141431e+02 >> > > 0 KSP Residual norm 5.187063704081e+00 >> > > 1 KSP Residual norm 4.254799504045e-13 >> > > Line search: gnorm after quadratic fit 3.171238299438e+02 >> > > Line search: Cubically determined step, current gnorm >> 2.859321807369e+02 lambda=4.9550691080557742e-02 >> > > 31 SNES Function norm 2.859321807369e+02 >> > > 0 KSP Residual norm 2.400449127985e+01 >> > > 1 KSP Residual norm 5.221032480453e-13 >> > > Line search: gnorm after quadratic fit 1.812538817802e+03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 6.647888939229e+02 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.905120335847e+02 lambda=7.3371687404129469e-03 >> > > Line search: Cubically determined step, current gnorm >> 2.857698450683e+02 lambda=1.3231746793531958e-03 >> > > 32 SNES Function norm 2.857698450683e+02 >> > > 0 KSP Residual norm 7.438521293559e+00 >> > > 1 KSP Residual norm 1.293652874831e-12 >> > > Line search: gnorm after quadratic fit 3.600694148787e+02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.932936811991e+02 lambda=5.0000000000000003e-02 >> > > Line search: Cubically determined step, current gnorm >> 2.832774969882e+02 lambda=1.8636088141277370e-02 >> > > 33 SNES Function norm 2.832774969882e+02 >> > > 0 KSP Residual norm 2.676138557891e+00 >> > > 1 KSP Residual norm 5.204105674042e-12 >> > > Line search: gnorm after quadratic fit 2.698470565576e+02 >> > > Line search: Quadratically determined step, >> lambda=1.0000000000000001e-01 >> > > 34 SNES Function norm 2.698470565576e+02 >> > > 0 KSP Residual norm 1.009562156863e+01 >> > > 1 KSP Residual norm 3.544140587695e-13 >> > > Line search: gnorm after quadratic fit 5.672695948559e+02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.197216154647e+02 lambda=5.0000000000000003e-02 >> > > Line search: Cubically determined step, current gnorm >> 2.694068135292e+02 lambda=1.0762403784106927e-02 >> > > 35 SNES Function norm 2.694068135292e+02 >> > > 0 KSP Residual norm 3.927549314525e+00 >> > > 1 KSP Residual norm 2.619134786598e-13 >> > > Line search: gnorm after quadratic fit 2.646675787349e+02 >> > > Line search: Quadratically determined step, >> lambda=1.0000000000000001e-01 >> > > 36 SNES Function norm 2.646675787349e+02 >> > > 0 KSP Residual norm 3.630219417922e+01 >> > > 1 KSP Residual norm 1.546302717349e-12 >> > > Line search: gnorm after quadratic fit 1.827432666108e+04 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.342968941151e+03 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 8.008633273369e+02 lambda=2.5000000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.490753494196e+02 lambda=1.2345129233072847e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.682474011960e+02 lambda=3.3291959087019770e-03 >> > > Line search: Cubically determined step, current gnorm >> 2.646227701989e+02 lambda=4.0529212866107715e-04 >> > > 37 SNES Function norm 2.646227701989e+02 >> > > 0 KSP Residual norm 8.122774697994e+00 >> > > 1 KSP Residual norm 1.316362046092e-13 >> > > Line search: gnorm after quadratic fit 4.731092571363e+02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.030088374328e+02 lambda=5.0000000000000003e-02 >> > > Line search: Cubically determined step, current gnorm >> 2.637462652877e+02 lambda=9.1057248517509397e-03 >> > > 38 SNES Function norm 2.637462652877e+02 >> > > 0 KSP Residual norm 2.601520363063e+00 >> > > 1 KSP Residual norm 1.060764270007e-12 >> > > Line search: gnorm after quadratic fit 2.536856446094e+02 >> > > Line search: Quadratically determined step, >> lambda=1.0000000000000001e-01 >> > > 39 SNES Function norm 2.536856446094e+02 >> > > 0 KSP Residual norm 5.447955134327e+01 >> > > 1 KSP Residual norm 2.556989975730e-12 >> > > Line search: gnorm after quadratic fit 9.199250935618e+03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.998238940105e+03 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 6.227083769291e+02 lambda=2.5000000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.852215674478e+02 lambda=8.5024965111563117e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.537821339347e+02 lambda=8.5024965111563122e-04 >> > > Line search: Cubically determined step, current gnorm >> 2.536484146652e+02 lambda=2.9594242443314720e-04 >> > > 40 SNES Function norm 2.536484146652e+02 >> > > 0 KSP Residual norm 3.357359266965e+01 >> > > 1 KSP Residual norm 8.485166742752e-11 >> > > Line search: gnorm after quadratic fit 3.327150899857e+03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 8.660943990394e+02 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.428891921377e+02 lambda=2.2262238648584176e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.550059920785e+02 lambda=3.9120439672600755e-03 >> > > Line search: Cubically determined step, current gnorm >> 2.535425543202e+02 lambda=8.8078244093807846e-04 >> > > 41 SNES Function norm 2.535425543202e+02 >> > > 0 KSP Residual norm 1.982789391732e+01 >> > > 1 KSP Residual norm 1.156473750758e-11 >> > > Line search: gnorm after quadratic fit 9.648483369708e+02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 4.023504841042e+02 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.554919970151e+02 lambda=8.7092873850291869e-03 >> > > Line search: Cubically determined step, current gnorm >> 2.532490636747e+02 lambda=2.4564558988847251e-03 >> > > 42 SNES Function norm 2.532490636747e+02 >> > > 0 KSP Residual norm 1.762994613361e+01 >> > > 1 KSP Residual norm 4.550684860593e-12 >> > > Line search: gnorm after quadratic fit 6.772107527838e+02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.370541870778e+02 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.532869639177e+02 lambda=7.7662700854918328e-03 >> > > Line search: Cubically determined step, current gnorm >> 2.527651129995e+02 lambda=3.8686733161537824e-03 >> > > 43 SNES Function norm 2.527651129995e+02 >> > > 0 KSP Residual norm 1.559278923951e+01 >> > > 1 KSP Residual norm 1.060470887103e-11 >> > > Line search: gnorm after quadratic fit 7.344361373020e+02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.498001534426e+02 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.530518382567e+02 lambda=7.6730113050967469e-03 >> > > Line search: Cubically determined step, current gnorm >> 2.523423548732e+02 lambda=3.4156098513217236e-03 >> > > 44 SNES Function norm 2.523423548732e+02 >> > > 0 KSP Residual norm 1.190500639095e+01 >> > > 1 KSP Residual norm 6.311739265577e-12 >> > > Line search: gnorm after quadratic fit 4.875196633557e+02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.933215922947e+02 lambda=5.0000000000000003e-02 >> > > Line search: Cubically determined step, current gnorm >> 2.516782376717e+02 lambda=9.8878729665301743e-03 >> > > 45 SNES Function norm 2.516782376717e+02 >> > > 0 KSP Residual norm 1.003632001309e+01 >> > > 1 KSP Residual norm 7.039473047666e-13 >> > > Line search: gnorm after quadratic fit 3.417133560813e+02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.636443273929e+02 lambda=5.0000000000000003e-02 >> > > Line search: Cubically determined step, current gnorm >> 2.499729768042e+02 lambda=1.5332495922160540e-02 >> > > 46 SNES Function norm 2.499729768042e+02 >> > > 0 KSP Residual norm 5.252587112411e+01 >> > > 1 KSP Residual norm 2.072629114336e-12 >> > > Line search: gnorm after quadratic fit 7.891803681498e+03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.819076698717e+03 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 5.911876424956e+02 lambda=2.4538865368827514e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.688195882303e+02 lambda=6.5764457912135515e-03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.500076295129e+02 lambda=6.5764457912135523e-04 >> > > Line search: Cubically determined step, current gnorm >> 2.499390700783e+02 lambda=2.7231956365922875e-04 >> > > 47 SNES Function norm 2.499390700783e+02 >> > > 0 KSP Residual norm 4.007648116930e+01 >> > > 1 KSP Residual norm 5.646654234336e-11 >> > > Line search: gnorm after quadratic fit 6.276152857499e+03 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 1.418274035925e+03 lambda=5.0000000000000003e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 4.785345842563e+02 lambda=2.5000000000000001e-02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 2.665412152699e+02 lambda=8.0607289886479045e-03 >> > > Line search: Cubically determined step, current gnorm >> 2.499109739904e+02 lambda=8.0607289886479045e-04 >> > > 48 SNES Function norm 2.499109739904e+02 >> > > 0 KSP Residual norm 1.339756751889e+01 >> > > 1 KSP Residual norm 2.559175980945e-13 >> > > Line search: gnorm after quadratic fit 6.052259901869e+02 >> > > Line search: Cubic step no good, shrinking lambda, current >> gnorm 3.217431518450e+02 lambda=5.0000000000000003e-02 >> > > Line search: Cubically determined step, current gnorm >> 2.496541765916e+02 lambda=7.0239599632283649e-03 >> > > 49 SNES Function norm 2.496541765916e+02 >> > > 0 KSP Residual norm 5.340771873687e+00 >> > > 1 KSP Residual norm 1.207454778077e-13 >> > > Line search: gnorm after quadratic fit 2.760767095070e+02 >> > > Line search: Cubically determined step, current gnorm >> 2.491630276458e+02 lambda=5.0000000000000003e-02 >> > > 50 SNES Function norm 2.491630276458e+02 >> > > >> > > >> > > On Sat, Aug 26, 2017 at 11:45 PM, Barry Smith >> wrote: >> > > >> > > > On Aug 26, 2017, at 10:43 PM, zakaryah . >> wrote: >> > > > >> > > > Hi Barry - many thanks for taking the time to understand my many >> problems and providing so much help. >> > > > >> > > > The reason I was concerned that I could not alter the linesearch >> was when I tried to use bt instead of the L-BFGS default, cp, the code >> crashed with an error like "Could not get Jacobian". Maybe this is an >> incompatibility like you say, since L-BFGS only uses the initial Jacobian >> and I never tried setting the scale type. >> > > > >> > > > I took your advice and tried to shrink the problem. First I tried >> shrinking by a factor 1000 but this converged very quickly with all test >> data I could provide, including the data which was problematic with the >> large grid. So I settled for a reduction in size by a factor 125. The >> grid size is 13,230. This is a decent test case because the solver fails >> to converge with the options I was using before, and it is small enough >> that I can run it with the options you suggested (-snes_fd_color -snes_type >> newtonls -snes_monitor -snes_linesearch_monitor -ksp_monitor -pc_type lu). >> > > > >> > > > The output is 1800 lines long - how shall I share it? >> > > >> > > Just email it, that is small enough for email. >> > > >> > > Barry >> > > >> > > > >> > > > >> > > > >> > > > >> > > > On Sat, Aug 26, 2017 at 7:38 PM, Barry Smith >> wrote: >> > > > >> > > > > On Aug 26, 2017, at 5:56 PM, zakaryah . >> wrote: >> > > > > >> > > > > I'm using PETSc's SNES methods to solve PDEs which result from >> Euler-Lagrange equations for the strain energy of a 3D displacement field. >> There is an additional term in the Lagrangian which describes external >> forces which arise from various data sets, and that term contains >> nonlinearities (field terms higher than linear). The grid has about 1.6e6 >> elements, and the displacement field has 3 components at each grid element. >> > > > > >> > > > > I'm trying to solve a sequence of successively more complicated >> equations, and the latest equation is failing to converge on some data >> sets. In particular, the methods were successful for the infinitesimal bulk >> strain (compression) energy, as well as the full infinitesimal strain >> energy (bulk + shear), but I'm now trying to generalize to the finite >> strain, as certain data sets are known to result from displacement fields >> for which the infinitesimal strain is a poor approximation. >> > > > > >> > > > > I'm using a DMDA, closely following example 48, and my preferred >> solver is L-BFGS. >> > > > >> > > > So you are using ? >> > > > >> > > > -snes_type qn -snes_qn_type lbfgs >> > > > >> > > > > >> > > > > I have read the FAQs "Why is Newton's method not converging??" >> and "Why is my iterative linear solver not converging??"? which have raised >> a number of questions: >> > > > >> > > > Quasi Newton methods either don't use Jacobians or use only the >> initial Jacobian (the idea behind quasi-Newton methods is to approximate >> Jacobian information from previous iterations without having the user >> compute a Jacobian at each iteration). With PETSc's qn it only uses the >> Jacobian if you use the option >> > > > >> > > > -snes_qn_scale_type Jacobian >> > > > >> > > > otherwise the Jacobian is never computed or used >> > > > >> > > > >> > > > > >> > > > > Is there documentation for the DMDA/SNES methods somewhere? I >> don't understand these very well. For example, I am not allocating any >> matrix for the global Jacobian, and I believe this prevents me from >> changing the line search. If I'm mistaken I would love to see an example >> of changing the line search type while using DMDA/SNES. >> > > > >> > > > Whether you provide a Jacobian or not is orthogonal to the line >> search. >> > > > >> > > > You should be able to change the line search with >> > > > >> > > > -snes_linesearch_type bt or nleqerr or basic or l2 or cp >> > > > >> > > > not all of them may work with qn >> > > > >> > > > >> > > > > >> > > > > I don't know how to interpret the linesearch monitor. Even for >> problems which are converging properly, the linesearch monitor reports >> "lssucceed=0" on every iteration. Is this a problem? >> > > > >> > > > It returns a 0 if the line search does not believe it has >> achieved "sufficient decrease" in the function norm (or possibly some other >> measure of decrease) you should run -snes_linesearch_monitor also with the >> option -snes_monitor to see what is happening to the function norm >> > > > >> > > > For qn you can add the option >> > > > >> > > > -snes_qn_monitor >> > > > >> > > > to get more detailed monitoring >> > > > >> > > > >> > > > > >> > > > > I'm also having trouble understanding the methods for >> troubleshooting. I suspect that I've made an error in the analytical >> Jacobian, which has a rather large number of non-zero elements, but I have >> no idea how to use -snes_type test -snes_test_display. The FAQs mention >> that some troubleshooting tools are more useful for small test problems. >> How small is small? >> > > > >> > > > Tiny, at most a few dozen rows and columns in the Jacobin. >> > > > >> > > > You should run without the -snes_test_display information, what >> does it say? Does it indicate the Jacobian or report there is likely a >> problem? >> > > > >> > > > With DMDA you can also use -snes_fd_color to have PETSc compute >> the Jacobian for you instead of using your analytical form. If it works >> with this, but not your Jacobian then your Jacobian is wrong. >> > > > >> > > > > When I try to run the program with -snes_type test >> -snes_test_display, I get errors like: >> > > > > >> > > > > [0]PETSC ERROR: Argument out of range [0]PETSC ERROR: Local index >> 1076396032 too large 4979879 (max) at 0 >> > > > > >> > > > > The second size is 1 less than the number of field elements, >> while the first number seems too large for any aspect of the problem - the >> Jacobian has at most 59 non-zero columns per row. >> > > > > >> > > > > Because I suspect a possible error in the Jacobian, I ran with >> -snes_mf_operator -pc_type ksp -ksp_ksp_rtol 1e-12 and observed very >> similar failure to converge (diverging residual) as with the explicit >> Jacobian. >> > > > >> > > > What do you get with -ksp_monitor -ksp_ksp_monitor it sounds >> like the true Jacobian is either very ill-conditioned or your function >> evaluation is wrong. >> > > > >> > > > > Do I need to set an SNES method which is somehow compatible with >> the "matrix-free" approach? If I instead use -snes_mf, the problem seems to >> converge, but horrendously slowly (true residual relative decrease by about >> 1e-5 per iteration). I suppose this supports my suspicion that the >> Jacobian is incorrect but doesn't really suggest a solution. >> > > > > >> > > > > Is it possible that the analytical Jacobian is correct, but >> somehow pathological, which causes the SNES to diverge? >> > > > >> > > > Yes >> > > > >> > > > > Neither the Jacobian nor the function have singularities. >> > > > > >> > > > > Thanks for any help you can provide! >> > > > >> > > > Try really hard to set up a small problem (like just use a very >> coarse grid) to experiment with as you try to get convergence. Using a big >> problem for debugging convergence is a recipe for pain. >> > > > >> > > > Also since you have a Jacobian I would start with -snes_fd_color >> -snes_type ls -snes_monitor -snes_linesearch_monitor -ksp_monitor -pc_type >> lu (not on a huge problem), what happens? Send the output >> > > > >> > > > Barry >> > > > >> > > > >> > > > >> > > >> > > >> > >> > >> >> > -------------- next part -------------- An HTML attachment was scrubbed... URL: From zakaryah at gmail.com Sun Aug 27 13:23:13 2017 From: zakaryah at gmail.com (zakaryah .) Date: Sun, 27 Aug 2017 14:23:13 -0400 Subject: [petsc-users] A number of questions about DMDA with SNES and Quasi-Newton methods In-Reply-To: References: <020DAED9-AAAD-4741-976B-BB2EF6C79D3F@mcs.anl.gov> <5BF530F6-8D79-47E6-B2C5-B0702FF2AA59@mcs.anl.gov> <7EE84495-4346-4BFB-B9AD-BCAA3C722461@mcs.anl.gov> Message-ID: I ran the smaller grid problem with -snes_test_display -snes_fd_color, and it did not crash (setting -snes_fd_color was apparently a crucial step). The result was: Norm of matrix ratio 0., difference 0. (user-defined state) Norm of matrix ratio 0., difference 0. (constant state -1.0) which suggests to me that the Jacobian is correct. Is it possible that QN is just a bad approach for this problem, or that I need to adjust the default parameters? On Sun, Aug 27, 2017 at 1:54 PM, zakaryah . wrote: > Is it suspicious that the KSP converges so quickly? I have no experience > with how the solvers behave on such small grids. > > Also, I ran the code with -snes_type test on a very small grid (1530 > elements). The simpler version of the PDE ran fine, and showed good > agreement of the matrices. However, the more complicated version crashes > with the following errors: > > Testing hand-coded Jacobian, if the ratio is > > O(1.e-8), the hand-coded Jacobian is probably correct. > > Run with -snes_test_display to show difference > > of hand-coded and finite difference Jacobian. > > [0]PETSC ERROR: --------------------- Error Message > -------------------------------------------------------------- > > [0]PETSC ERROR: Argument out of range > > [0]PETSC ERROR: Inserting a new nonzero at (7,0) in the matrix > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html > for trouble shooting. > > [0]PETSC ERROR: Petsc Release Version 3.7.3, Jul, 24, 2016 > > [0]PETSC ERROR: #1 MatSetValues_SeqAIJ() line 484 in path>/PETSc/build/petsc-3.7.3/src/mat/impls/aij/seq/aij.c > > [0]PETSC ERROR: #2 MatSetValues() line 1190 in path>/PETSc/build/petsc-3.7.3/src/mat/interface/matrix.c > > [0]PETSC ERROR: #3 MatSetValuesLocal() line 2053 in path>/PETSc/build/petsc-3.7.3/src/mat/interface/matrix.c > > [0]PETSC ERROR: #4 MatSetValuesStencil() line 1447 in path>/PETSc/build/petsc-3.7.3/src/mat/interface/matrix.c > > Does this indicate a bug in the Jacobian calculation? I don't think I set > values outside of the stencil... > > On Sun, Aug 27, 2017 at 12:14 AM, zakaryah . wrote: > >> Sure - it was this: >> >> mpiexec -n 1 -snes_fd_color -snes_type newtonls >> -snes_monitor -snes_linesearch_monitor -ksp_monitor -pc_type lu >> >> On Sun, Aug 27, 2017 at 12:11 AM, Barry Smith wrote: >> >>> >>> > On Aug 26, 2017, at 10:55 PM, zakaryah . wrote: >>> > >>> > Yes, except I changed "-snes_type ls" to "-snes_type newtonls" because >>> PETSc complained that ls wasn't a known method. >>> >>> Sorry, my memory is not as good as it used to be; but what other >>> options did you use? Send the exact command line. >>> >>> >>> Barry >>> ' >>> > >>> > On Sat, Aug 26, 2017 at 11:52 PM, Barry Smith >>> wrote: >>> > >>> > My exact options did you run with? >>> > >>> > > On Aug 26, 2017, at 10:48 PM, zakaryah . wrote: >>> > > >>> > > Here's the output, from the data set which does not converge with >>> l-bfgs: >>> > > >>> > > 0 SNES Function norm 1.370293318432e+04 >>> > > 0 KSP Residual norm 7.457506389218e+02 >>> > > 1 KSP Residual norm 2.244764079994e-10 >>> > > Line search: gnorm after quadratic fit 6.541298279196e+05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 8.963717927372e+04 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.788909416707e+04 lambda=2.5000000000000001e-02 >>> > > Line search: Cubically determined step, current gnorm >>> 1.340565762719e+04 lambda=1.2500000000000001e-02 >>> > > 1 SNES Function norm 1.340565762719e+04 >>> > > 0 KSP Residual norm 4.096066553372e+02 >>> > > 1 KSP Residual norm 3.313671167444e-11 >>> > > Line search: gnorm after quadratic fit 1.113749573695e+06 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.406390140546e+05 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.126781917443e+04 lambda=2.5000000000000001e-02 >>> > > Line search: Cubically determined step, current gnorm >>> 1.272988597973e+04 lambda=1.2500000000000001e-02 >>> > > 2 SNES Function norm 1.272988597973e+04 >>> > > 0 KSP Residual norm 8.291344597817e+01 >>> > > 1 KSP Residual norm 7.182258362182e-12 >>> > > Line search: gnorm after quadratic fit 1.121913743889e+04 >>> > > Line search: Quadratically determined step, >>> lambda=1.0000000000000001e-01 >>> > > 3 SNES Function norm 1.121913743889e+04 >>> > > 0 KSP Residual norm 6.830535877014e+01 >>> > > 1 KSP Residual norm 3.629826411580e-12 >>> > > Line search: gnorm after quadratic fit 9.966344973786e+03 >>> > > Line search: Quadratically determined step, >>> lambda=1.0000000000000001e-01 >>> > > 4 SNES Function norm 9.966344973786e+03 >>> > > 0 KSP Residual norm 5.137691531345e+01 >>> > > 1 KSP Residual norm 1.954502098181e-12 >>> > > Line search: gnorm after quadratic fit 8.905508641232e+03 >>> > > Line search: Quadratically determined step, >>> lambda=1.0000000000000001e-01 >>> > > 5 SNES Function norm 8.905508641232e+03 >>> > > 0 KSP Residual norm 4.295019262963e+01 >>> > > 1 KSP Residual norm 1.581527994925e-12 >>> > > Line search: gnorm after quadratic fit 7.599173694189e+03 >>> > > Line search: Quadratically determined step, >>> lambda=1.4157226463489950e-01 >>> > > 6 SNES Function norm 7.599173694189e+03 >>> > > 0 KSP Residual norm 3.520472291520e+01 >>> > > 1 KSP Residual norm 1.169994130568e-12 >>> > > Line search: gnorm after quadratic fit 6.797214843928e+03 >>> > > Line search: Quadratically determined step, >>> lambda=1.0000000000000001e-01 >>> > > 7 SNES Function norm 6.797214843928e+03 >>> > > 0 KSP Residual norm 2.683523206056e+01 >>> > > 1 KSP Residual norm 9.039858014119e-13 >>> > > Line search: gnorm after quadratic fit 6.098038917364e+03 >>> > > Line search: Quadratically determined step, >>> lambda=1.0000000000000001e-01 >>> > > 8 SNES Function norm 6.098038917364e+03 >>> > > 0 KSP Residual norm 2.300710560681e+01 >>> > > 1 KSP Residual norm 1.010402303464e-12 >>> > > Line search: gnorm after quadratic fit 5.486151385552e+03 >>> > > Line search: Quadratically determined step, >>> lambda=1.0000000000000001e-01 >>> > > 9 SNES Function norm 5.486151385552e+03 >>> > > 0 KSP Residual norm 2.824628827619e+01 >>> > > 1 KSP Residual norm 1.009589866569e-12 >>> > > Line search: gnorm after quadratic fit 4.964991021247e+03 >>> > > Line search: Quadratically determined step, >>> lambda=1.0000000000000001e-01 >>> > > 10 SNES Function norm 4.964991021247e+03 >>> > > 0 KSP Residual norm 6.285926028595e+01 >>> > > 1 KSP Residual norm 2.833546214180e-12 >>> > > Line search: gnorm after quadratic fit 2.100041391472e+04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 5.804051080767e+03 lambda=5.0000000000000003e-02 >>> > > Line search: Cubically determined step, current gnorm >>> 4.893296169579e+03 lambda=2.5000000000000001e-02 >>> > > 11 SNES Function norm 4.893296169579e+03 >>> > > 0 KSP Residual norm 1.688978282804e+01 >>> > > 1 KSP Residual norm 5.927677470786e-13 >>> > > Line search: gnorm after quadratic fit 4.400894622431e+03 >>> > > Line search: Quadratically determined step, >>> lambda=1.0000000000000001e-01 >>> > > 12 SNES Function norm 4.400894622431e+03 >>> > > 0 KSP Residual norm 1.481197699600e+01 >>> > > 1 KSP Residual norm 4.522572128105e-13 >>> > > Line search: Using full step: fnorm 4.400894622431e+03 gnorm >>> 2.094971849007e+03 >>> > > 13 SNES Function norm 2.094971849007e+03 >>> > > 0 KSP Residual norm 3.514164563318e+00 >>> > > 1 KSP Residual norm 3.022385947499e-13 >>> > > Line search: gnorm after quadratic fit 1.687641025382e+03 >>> > > Line search: Quadratically determined step, >>> lambda=2.0307116693368590e-01 >>> > > 14 SNES Function norm 1.687641025382e+03 >>> > > 0 KSP Residual norm 2.138591884686e+00 >>> > > 1 KSP Residual norm 4.023500814078e-14 >>> > > Line search: Using full step: fnorm 1.687641025382e+03 gnorm >>> 1.131934218470e+03 >>> > > 15 SNES Function norm 1.131934218470e+03 >>> > > 0 KSP Residual norm 3.245035110327e+00 >>> > > 1 KSP Residual norm 1.293626215269e-13 >>> > > Line search: Using full step: fnorm 1.131934218470e+03 gnorm >>> 7.340573607307e+02 >>> > > 16 SNES Function norm 7.340573607307e+02 >>> > > 0 KSP Residual norm 1.957698957904e+00 >>> > > 1 KSP Residual norm 3.444648967078e-13 >>> > > Line search: Using full step: fnorm 7.340573607307e+02 gnorm >>> 5.024723505168e+02 >>> > > 17 SNES Function norm 5.024723505168e+02 >>> > > 0 KSP Residual norm 2.510538703839e+00 >>> > > 1 KSP Residual norm 8.570440675253e-14 >>> > > Line search: gnorm after quadratic fit 4.548776456608e+02 >>> > > Line search: Quadratically determined step, >>> lambda=1.0000000000000001e-01 >>> > > 18 SNES Function norm 4.548776456608e+02 >>> > > 0 KSP Residual norm 6.741705718178e-01 >>> > > 1 KSP Residual norm 1.650556120809e-14 >>> > > Line search: Using full step: fnorm 4.548776456608e+02 gnorm >>> 1.351189086642e+02 >>> > > 19 SNES Function norm 1.351189086642e+02 >>> > > 0 KSP Residual norm 7.653741241950e+00 >>> > > 1 KSP Residual norm 8.326848236950e-14 >>> > > Line search: gnorm after quadratic fit 4.215455105006e+02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.889750369356e+02 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.358691836999e+02 lambda=1.0303015930243279e-02 >>> > > Line search: Cubically determined step, current gnorm >>> 1.348911963390e+02 lambda=3.5279526770504110e-03 >>> > > 20 SNES Function norm 1.348911963390e+02 >>> > > 0 KSP Residual norm 4.209281176918e+00 >>> > > 1 KSP Residual norm 1.233232881375e-13 >>> > > Line search: gnorm after quadratic fit 1.860023264470e+02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.413911132196e+02 lambda=5.0000000000000003e-02 >>> > > Line search: Cubically determined step, current gnorm >>> 1.339597869053e+02 lambda=1.5787957598629023e-02 >>> > > 21 SNES Function norm 1.339597869053e+02 >>> > > 0 KSP Residual norm 1.718484765841e+00 >>> > > 1 KSP Residual norm 6.666016296543e-14 >>> > > Line search: gnorm after quadratic fit 1.326878521472e+02 >>> > > Line search: Quadratically determined step, >>> lambda=1.0000000000000001e-01 >>> > > 22 SNES Function norm 1.326878521472e+02 >>> > > 0 KSP Residual norm 1.515373499919e+00 >>> > > 1 KSP Residual norm 2.259154130795e-12 >>> > > Line search: gnorm after quadratic fit 1.226907316391e+02 >>> > > Line search: Quadratically determined step, >>> lambda=1.0000000000000001e-01 >>> > > 23 SNES Function norm 1.226907316391e+02 >>> > > 0 KSP Residual norm 1.080252936903e+00 >>> > > 1 KSP Residual norm 1.847020526683e-14 >>> > > Line search: gnorm after quadratic fit 1.163632111851e+02 >>> > > Line search: Quadratically determined step, >>> lambda=1.0000000000000001e-01 >>> > > 24 SNES Function norm 1.163632111851e+02 >>> > > 0 KSP Residual norm 2.491746958382e+00 >>> > > 1 KSP Residual norm 6.389134193637e-14 >>> > > Line search: gnorm after quadratic fit 1.345487153563e+02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.169738363622e+02 lambda=4.4108900954515480e-02 >>> > > Line search: Cubically determined step, current gnorm >>> 1.152177638108e+02 lambda=1.9997442889243631e-02 >>> > > 25 SNES Function norm 1.152177638108e+02 >>> > > 0 KSP Residual norm 5.364385501004e+00 >>> > > 1 KSP Residual norm 8.457149562463e-14 >>> > > Line search: gnorm after quadratic fit 2.722095758964e+02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.480946353374e+02 lambda=5.0000000000000003e-02 >>> > > Line search: Cubically determined step, current gnorm >>> 1.150680255994e+02 lambda=6.3560128131639167e-03 >>> > > 26 SNES Function norm 1.150680255994e+02 >>> > > 0 KSP Residual norm 4.302025268263e+00 >>> > > 1 KSP Residual norm 1.017526937941e-13 >>> > > Line search: gnorm after quadratic fit 1.956300983573e+02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.318600522939e+02 lambda=5.0000000000000003e-02 >>> > > Line search: Cubically determined step, current gnorm >>> 1.147123505014e+02 lambda=7.6060788653548803e-03 >>> > > 27 SNES Function norm 1.147123505014e+02 >>> > > 0 KSP Residual norm 6.195463111324e+00 >>> > > 1 KSP Residual norm 1.235283250361e-13 >>> > > Line search: gnorm after quadratic fit 3.324821547049e+02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.612593208504e+02 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.147389525772e+02 lambda=6.1750939181374294e-03 >>> > > Line search: Cubically determined step, current gnorm >>> 1.145411432123e+02 lambda=3.0078592586792975e-03 >>> > > 28 SNES Function norm 1.145411432123e+02 >>> > > 0 KSP Residual norm 1.454704250187e+01 >>> > > 1 KSP Residual norm 2.368485174123e-13 >>> > > Line search: gnorm after quadratic fit 1.216293873116e+03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.796524621727e+02 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.359314163651e+02 lambda=1.4867675803955788e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.146009802557e+02 lambda=1.4867675803955788e-03 >>> > > Line search: Cubically determined step, current gnorm >>> 1.145096815033e+02 lambda=5.5250912472932839e-04 >>> > > 29 SNES Function norm 1.145096815033e+02 >>> > > 0 KSP Residual norm 3.430451345093e+01 >>> > > 1 KSP Residual norm 1.069396165938e-12 >>> > > Line search: gnorm after quadratic fit 1.161329407098e+04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.260690718050e+03 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 5.696806489042e+02 lambda=2.5000000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.960149915648e+02 lambda=1.1276129246469476e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.158113641658e+02 lambda=1.5873910451430554e-03 >>> > > Line search: Cubically determined step, current gnorm >>> 1.145062232916e+02 lambda=1.5873910451430555e-04 >>> > > 30 SNES Function norm 1.145062232916e+02 >>> > > 0 KSP Residual norm 2.662578971526e+01 >>> > > 1 KSP Residual norm 5.464011789728e-13 >>> > > Line search: gnorm after quadratic fit 4.375119254490e+03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.038018103928e+03 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.169328002874e+02 lambda=2.3789161387159519e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.262835432714e+02 lambda=5.9737415571960795e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.145626045197e+02 lambda=5.9737415571960802e-04 >>> > > Line search: Cubically determined step, current gnorm >>> 1.144968604079e+02 lambda=1.6421773527706333e-04 >>> > > 31 SNES Function norm 1.144968604079e+02 >>> > > 0 KSP Residual norm 6.322033697338e+01 >>> > > 1 KSP Residual norm 1.507157991448e-12 >>> > > Line search: gnorm after quadratic fit 5.809243699277e+04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 9.460487584142e+03 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.893183483197e+03 lambda=2.5000000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 4.960337007072e+02 lambda=1.2500000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.771527792790e+02 lambda=5.3912931685137378e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.150137639707e+02 lambda=5.3912931685137376e-04 >>> > > Line search: Cubically determined step, current gnorm >>> 1.144964484571e+02 lambda=5.3912931685137380e-05 >>> > > 32 SNES Function norm 1.144964484571e+02 >>> > > 0 KSP Residual norm 3.859510930996e+01 >>> > > 1 KSP Residual norm 8.069118044382e-13 >>> > > Line search: gnorm after quadratic fit 1.106329930525e+04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.155884463041e+03 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 5.933963819094e+02 lambda=2.5000000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.849629797377e+02 lambda=9.7744286136270241e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.150857687050e+02 lambda=9.7744286136270254e-04 >>> > > Line search: Cubically determined step, current gnorm >>> 1.144922906340e+02 lambda=9.7744286136270254e-05 >>> > > 33 SNES Function norm 1.144922906340e+02 >>> > > 0 KSP Residual norm 4.952038022394e+01 >>> > > 1 KSP Residual norm 7.460263245424e-13 >>> > > Line search: gnorm after quadratic fit 3.005091127220e+04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 5.229308416025e+03 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.138600794682e+03 lambda=2.5000000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.390856262238e+02 lambda=1.2500000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.394997214983e+02 lambda=4.4582997750629580e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.146836358799e+02 lambda=4.4582997750629581e-04 >>> > > Line search: Cubically determined step, current gnorm >>> 1.144895966587e+02 lambda=4.7644082443915877e-05 >>> > > 34 SNES Function norm 1.144895966587e+02 >>> > > 0 KSP Residual norm 1.146914786457e+02 >>> > > 1 KSP Residual norm 4.791627042400e-12 >>> > > Line search: gnorm after quadratic fit 2.601294145944e+05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.324148513778e+04 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 5.247478406023e+03 lambda=2.5000000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.200340900661e+03 lambda=1.2500000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.696223112300e+02 lambda=6.1514413845115794e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.342365431983e+02 lambda=1.7502929694284564e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.146686063035e+02 lambda=1.7502929694284566e-04 >>> > > Line search: Cubically determined step, current gnorm >>> 1.144895868489e+02 lambda=1.7502929694284566e-05 >>> > > 35 SNES Function norm 1.144895868489e+02 >>> > > 0 KSP Residual norm 6.311017209658e+01 >>> > > 1 KSP Residual norm 8.384445939117e-13 >>> > > Line search: gnorm after quadratic fit 5.781533400572e+04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 9.419557746031e+03 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.886081770030e+03 lambda=2.5000000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 4.945810143740e+02 lambda=1.2500000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.767820854837e+02 lambda=5.3859001959289735e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.150034040559e+02 lambda=5.3859001959289732e-04 >>> > > Line search: Cubically determined step, current gnorm >>> 1.144891501665e+02 lambda=5.3859001959289732e-05 >>> > > 36 SNES Function norm 1.144891501665e+02 >>> > > 0 KSP Residual norm 3.880748384332e+01 >>> > > 1 KSP Residual norm 6.400339290453e-13 >>> > > Line search: gnorm after quadratic fit 1.122504184426e+04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.180728237366e+03 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 5.987870621566e+02 lambda=2.5000000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.863711604331e+02 lambda=9.8150771384688824e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.150916783781e+02 lambda=9.8150771384688824e-04 >>> > > Line search: Cubically determined step, current gnorm >>> 1.144850837411e+02 lambda=9.8150771384688832e-05 >>> > > 37 SNES Function norm 1.144850837411e+02 >>> > > 0 KSP Residual norm 4.811537498557e+01 >>> > > 1 KSP Residual norm 9.738167670242e-13 >>> > > Line search: gnorm after quadratic fit 2.784098355218e+04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 4.885118868254e+03 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.074843354348e+03 lambda=2.5000000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.255202820836e+02 lambda=1.2500000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.365202996130e+02 lambda=4.3204204582016374e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.146504919412e+02 lambda=4.3204204582016374e-04 >>> > > Line search: Cubically determined step, current gnorm >>> 1.144822306241e+02 lambda=5.0376546850227848e-05 >>> > > 38 SNES Function norm 1.144822306241e+02 >>> > > 0 KSP Residual norm 1.120914002482e+02 >>> > > 1 KSP Residual norm 5.452125292284e-12 >>> > > Line search: gnorm after quadratic fit 2.427186680567e+05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.112196656857e+04 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 4.967397366072e+03 lambda=2.5000000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.149551659770e+03 lambda=1.2500000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.529630886791e+02 lambda=6.0885216927030559e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.315267519231e+02 lambda=1.6656233536183130e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.146353659250e+02 lambda=1.6656233536183130e-04 >>> > > Line search: Cubically determined step, current gnorm >>> 1.144820487391e+02 lambda=1.6656233536183130e-05 >>> > > 39 SNES Function norm 1.144820487391e+02 >>> > > 0 KSP Residual norm 7.182416170980e+01 >>> > > 1 KSP Residual norm 1.292147133333e-12 >>> > > Line search: gnorm after quadratic fit 8.255331293322e+04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.302939895170e+04 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.501228089911e+03 lambda=2.5000000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 6.185010378583e+02 lambda=1.2500000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.088179821424e+02 lambda=5.7489510178867142e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.168272901121e+02 lambda=9.7452649444612811e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.144951972300e+02 lambda=9.7452649444612822e-05 >>> > > Line search: Cubically determined step, current gnorm >>> 1.144807676687e+02 lambda=2.2399506502463798e-05 >>> > > 40 SNES Function norm 1.144807676687e+02 >>> > > 0 KSP Residual norm 1.728679810285e+02 >>> > > 1 KSP Residual norm 3.878068639716e-12 >>> > > Line search: gnorm after quadratic fit 9.011020578535e+05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.111818830011e+05 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.504789858103e+04 lambda=2.5000000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.754312133162e+03 lambda=1.2500000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 7.212492111975e+02 lambda=6.2500000000000003e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.199969180537e+02 lambda=2.6424184504193135e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.154794639440e+02 lambda=2.6424184504193136e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.144880673342e+02 lambda=2.6424184504193136e-05 >>> > > Line search: Cubically determined step, current gnorm >>> 1.144805461570e+02 lambda=3.8712107591125690e-06 >>> > > 41 SNES Function norm 1.144805461570e+02 >>> > > 0 KSP Residual norm 4.162780846202e+02 >>> > > 1 KSP Residual norm 1.732341544934e-11 >>> > > Line search: gnorm after quadratic fit 1.355673864369e+07 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.747523002884e+06 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.342205048417e+05 lambda=2.5000000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.425635699680e+04 lambda=1.2500000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 5.882150659178e+03 lambda=6.2500000000000003e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.259664786336e+03 lambda=3.1250000000000002e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.653670676209e+02 lambda=1.5625000000000001e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.453655830144e+02 lambda=5.8237455565260388e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.147659525018e+02 lambda=5.8237455565260393e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.144827915995e+02 lambda=5.8237455565260400e-06 >>> > > Line search: Cubically determined step, current gnorm >>> 1.144805080017e+02 lambda=6.6689295146509104e-07 >>> > > 42 SNES Function norm 1.144805080017e+02 >>> > > 0 KSP Residual norm 1.004135512581e+03 >>> > > 1 KSP Residual norm 3.867626041000e-09 >>> > > Line search: gnorm after quadratic fit 1.832578994882e+08 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.269698278878e+07 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.792476589915e+06 lambda=2.5000000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.420660371083e+05 lambda=1.2500000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 4.321686926168e+04 lambda=6.2500000000000003e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 6.548358078234e+03 lambda=3.1250000000000002e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.429504802276e+03 lambda=1.5625000000000001e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 4.317723385004e+02 lambda=7.8125000000000004e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.460079723095e+02 lambda=2.5078917343692407e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.147908977725e+02 lambda=2.5078917343692408e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.144833604238e+02 lambda=2.5078917343692412e-06 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.144805106824e+02 lambda=2.5078917343692411e-07 >>> > > Line search: Cubically determined step, current gnorm >>> 1.144805014337e+02 lambda=1.1468707119027746e-07 >>> > > 43 SNES Function norm 1.144805014337e+02 >>> > > 0 KSP Residual norm 2.418614573592e+03 >>> > > 1 KSP Residual norm 6.085078742847e-10 >>> > > Line search: gnorm after quadratic fit 2.598476259775e+09 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.262759415873e+08 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 4.116845970403e+07 lambda=2.5000000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 5.250465130250e+06 lambda=1.2500000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 6.863493884574e+05 lambda=6.2500000000000003e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 9.501468163771e+04 lambda=3.1250000000000002e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.482658980483e+04 lambda=1.5625000000000001e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.802395557883e+03 lambda=7.8125000000000004e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 6.788149582374e+02 lambda=3.9062500000000002e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.248828337038e+02 lambda=1.8333058767960295e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.186285836222e+02 lambda=3.7550993478654105e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.145209710139e+02 lambda=3.7550993478654107e-06 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.144808670668e+02 lambda=3.7550993478654111e-07 >>> > > Line search: Cubically determined step, current gnorm >>> 1.144805012252e+02 lambda=3.7550993478654114e-08 >>> > > 44 SNES Function norm 1.144805012252e+02 >>> > > 0 KSP Residual norm 1.432476672735e+03 >>> > > 1 KSP Residual norm 7.850524783892e-11 >>> > > Line search: gnorm after quadratic fit 5.336191593632e+08 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 6.625576866625e+07 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 8.181408387845e+06 lambda=2.5000000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.003310644422e+06 lambda=1.2500000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.236384273292e+05 lambda=6.2500000000000003e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.658430638069e+04 lambda=3.1250000000000002e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.977463068161e+03 lambda=1.5625000000000001e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 7.674238499253e+02 lambda=7.8125000000000004e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.333616820791e+02 lambda=3.3764776729281175e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.161349153752e+02 lambda=4.0497161764116874e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.144966925969e+02 lambda=4.0497161764116874e-06 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.144806214839e+02 lambda=4.0497161764116878e-07 >>> > > Line search: Cubically determined step, current gnorm >>> 1.144804979966e+02 lambda=5.6339112427782378e-08 >>> > > 45 SNES Function norm 1.144804979966e+02 >>> > > 0 KSP Residual norm 3.453401579761e+03 >>> > > 1 KSP Residual norm 4.197968028126e-09 >>> > > Line search: gnorm after quadratic fit 7.554006183767e+09 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 9.471974940372e+08 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.191613865049e+08 lambda=2.5000000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.509784334249e+07 lambda=1.2500000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.943752478560e+06 lambda=6.2500000000000003e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.597601716755e+05 lambda=3.1250000000000002e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.775572331075e+04 lambda=1.5625000000000001e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 6.418045407608e+03 lambda=7.8125000000000004e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.357066758731e+03 lambda=3.9062500000000002e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.859267839080e+02 lambda=1.9531250000000001e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.501494912160e+02 lambda=7.5160826909319168e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.148144926477e+02 lambda=7.5160826909319171e-06 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.144837498478e+02 lambda=7.5160826909319179e-07 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.144805227746e+02 lambda=7.5160826909319182e-08 >>> > > Line search: Cubically determined step, current gnorm >>> 1.144804974438e+02 lambda=9.6864021663644795e-09 >>> > > 46 SNES Function norm 1.144804974438e+02 >>> > > 0 KSP Residual norm 8.345139428850e+03 >>> > > 1 KSP Residual norm 1.027819754739e-09 >>> > > Line search: gnorm after quadratic fit 1.061319903906e+11 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.325012985379e+10 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.652236226640e+09 lambda=2.5000000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.055533971630e+08 lambda=1.2500000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.546607716763e+07 lambda=6.2500000000000003e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.134442858835e+06 lambda=3.1250000000000002e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.839168570687e+05 lambda=1.5625000000000001e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 4.830568178626e+04 lambda=7.8125000000000004e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 7.201776786081e+03 lambda=3.9062500000000002e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.540520468013e+03 lambda=1.9531250000000001e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 4.573504890506e+02 lambda=9.7656250000000005e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.516203908013e+02 lambda=3.2703670177372021e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.148480075676e+02 lambda=3.2703670177372022e-06 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.144841475328e+02 lambda=3.2703670177372023e-07 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.144805305720e+02 lambda=3.2703670177372021e-08 >>> > > Line search: Cubically determined step, current gnorm >>> 1.144804974367e+02 lambda=3.2703670177372025e-09 >>> > > 47 SNES Function norm 1.144804974367e+02 >>> > > 0 KSP Residual norm 4.668983500382e+03 >>> > > 1 KSP Residual norm 1.398997665317e-09 >>> > > Line search: gnorm after quadratic fit 1.865309565532e+10 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.336975299727e+09 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.934905088739e+08 lambda=2.5000000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.704520478641e+07 lambda=1.2500000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 4.728477809448e+06 lambda=6.2500000000000003e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 6.193001670096e+05 lambda=3.1250000000000002e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 8.610673238239e+04 lambda=1.5625000000000001e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.354711683605e+04 lambda=7.8125000000000004e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.589557246433e+03 lambda=3.9062500000000002e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 6.367851970709e+02 lambda=1.9531250000000001e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.136930269795e+02 lambda=9.0316845802227864e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.172186635069e+02 lambda=1.5831613287181393e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.145074017254e+02 lambda=1.5831613287181394e-06 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.144807499816e+02 lambda=1.5831613287181396e-07 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.144804983345e+02 lambda=1.5831613287181397e-08 >>> > > Line search: Cubically determined step, current gnorm >>> 1.144804971346e+02 lambda=5.2932921109871310e-09 >>> > > 48 SNES Function norm 1.144804971346e+02 >>> > > 0 KSP Residual norm 1.132678078317e+04 >>> > > 1 KSP Residual norm 2.477518733314e-10 >>> > > Line search: gnorm after quadratic fit 2.654659022365e+11 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.315296223725e+10 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 4.136635677074e+09 lambda=2.5000000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 5.152507060235e+08 lambda=1.2500000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 6.397060094478e+07 lambda=6.2500000000000003e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 7.898362012287e+06 lambda=3.1250000000000002e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 9.685179520906e+05 lambda=1.5625000000000001e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.194040779842e+05 lambda=7.8125000000000004e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.606415730227e+04 lambda=3.9062500000000002e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.902698091972e+03 lambda=1.9531250000000001e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 7.521549384652e+02 lambda=9.7656250000000005e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.288999778994e+02 lambda=4.1899746703195281e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.157880829786e+02 lambda=4.5470218451893824e-06 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.144935741206e+02 lambda=4.5470218451893828e-07 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.144806232638e+02 lambda=4.5470218451893831e-08 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.144804979250e+02 lambda=4.5470218451893835e-09 >>> > > Line search: Cubically determined step, current gnorm >>> 1.144804970825e+02 lambda=9.0293679903918216e-10 >>> > > 49 SNES Function norm 1.144804970825e+02 >>> > > 0 KSP Residual norm 2.712544829144e+04 >>> > > 1 KSP Residual norm 4.949246309677e-09 >>> > > Line search: gnorm after quadratic fit 3.650846005745e+12 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 4.565321055911e+11 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 5.711080201118e+10 lambda=2.5000000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 7.150022242308e+09 lambda=1.2500000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 8.965954117985e+08 lambda=6.2500000000000003e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.128096393645e+08 lambda=3.1250000000000002e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.429702091584e+07 lambda=1.5625000000000001e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.841819946536e+06 lambda=7.8125000000000004e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.465032956946e+05 lambda=3.9062500000000002e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.594210253794e+04 lambda=1.9531250000000001e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 6.141110278944e+03 lambda=9.7656250000000005e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.306952279045e+03 lambda=4.8828125000000003e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.754164864338e+02 lambda=2.4414062500000001e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.476861367158e+02 lambda=9.2451761406722810e-06 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.147929263780e+02 lambda=9.2451761406722810e-07 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.144836022952e+02 lambda=9.2451761406722821e-08 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.144805271860e+02 lambda=9.2451761406722831e-09 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.144804972895e+02 lambda=9.2451761406722839e-10 >>> > > Line search: Cubically determined step, current gnorm >>> 1.144804970737e+02 lambda=1.5633616333063305e-10 >>> > > 50 SNES Function norm 1.144804970737e+02 >>> > > 0 SNES Function norm 2.308693894796e+03 >>> > > 0 KSP Residual norm 8.981999720532e+00 >>> > > 1 KSP Residual norm 2.363170936183e-13 >>> > > Line search: Using full step: fnorm 2.308693894796e+03 gnorm >>> 7.571661187318e+02 >>> > > 1 SNES Function norm 7.571661187318e+02 >>> > > 0 KSP Residual norm 2.149614048903e+00 >>> > > 1 KSP Residual norm 9.511247057888e-13 >>> > > Line search: Using full step: fnorm 7.571661187318e+02 gnorm >>> 4.450081004997e+02 >>> > > 2 SNES Function norm 4.450081004997e+02 >>> > > 0 KSP Residual norm 1.706469075123e+01 >>> > > 1 KSP Residual norm 5.803815175472e-13 >>> > > Line search: gnorm after quadratic fit 1.510518198899e+03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 5.850796532980e+02 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 4.515983139755e+02 lambda=2.0602556887689423e-02 >>> > > Line search: Cubically determined step, current gnorm >>> 4.434800867235e+02 lambda=8.2396279492937211e-03 >>> > > 3 SNES Function norm 4.434800867235e+02 >>> > > 0 KSP Residual norm 3.208587171626e+00 >>> > > 1 KSP Residual norm 1.099072610659e-13 >>> > > Line search: gnorm after quadratic fit 4.080637194736e+02 >>> > > Line search: Quadratically determined step, >>> lambda=1.0000000000000001e-01 >>> > > 4 SNES Function norm 4.080637194736e+02 >>> > > 0 KSP Residual norm 8.136557176540e+00 >>> > > 1 KSP Residual norm 8.800137844173e-13 >>> > > Line search: gnorm after quadratic fit 5.261656549654e+02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 4.131114070934e+02 lambda=5.0000000000000003e-02 >>> > > Line search: Cubically determined step, current gnorm >>> 4.031614746044e+02 lambda=2.4674842039461482e-02 >>> > > 5 SNES Function norm 4.031614746044e+02 >>> > > 0 KSP Residual norm 7.609918907567e+00 >>> > > 1 KSP Residual norm 1.613159932655e-13 >>> > > Line search: gnorm after quadratic fit 5.353908064984e+02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 4.110480554132e+02 lambda=5.0000000000000003e-02 >>> > > Line search: Cubically determined step, current gnorm >>> 3.991168240716e+02 lambda=2.3079500036735322e-02 >>> > > 6 SNES Function norm 3.991168240716e+02 >>> > > 0 KSP Residual norm 3.800845472041e+00 >>> > > 1 KSP Residual norm 4.841682188278e-13 >>> > > Line search: gnorm after quadratic fit 3.787886582952e+02 >>> > > Line search: Quadratically determined step, >>> lambda=1.0000000000000001e-01 >>> > > 7 SNES Function norm 3.787886582952e+02 >>> > > 0 KSP Residual norm 1.892621919219e+00 >>> > > 1 KSP Residual norm 3.576655371800e-12 >>> > > Line search: gnorm after quadratic fit 3.440181918909e+02 >>> > > Line search: Quadratically determined step, >>> lambda=1.0000000000000001e-01 >>> > > 8 SNES Function norm 3.440181918909e+02 >>> > > 0 KSP Residual norm 3.559759789147e+00 >>> > > 1 KSP Residual norm 8.347521826622e-13 >>> > > Line search: gnorm after quadratic fit 3.287993515195e+02 >>> > > Line search: Quadratically determined step, >>> lambda=1.0000000000000001e-01 >>> > > 9 SNES Function norm 3.287993515195e+02 >>> > > 0 KSP Residual norm 1.825073540507e+00 >>> > > 1 KSP Residual norm 8.352745008123e-14 >>> > > Line search: Using full step: fnorm 3.287993515195e+02 gnorm >>> 2.710650507416e+02 >>> > > 10 SNES Function norm 2.710650507416e+02 >>> > > 0 KSP Residual norm 7.568432945608e-01 >>> > > 1 KSP Residual norm 2.780715252274e-14 >>> > > Line search: Using full step: fnorm 2.710650507416e+02 gnorm >>> 1.513359047342e+02 >>> > > 11 SNES Function norm 1.513359047342e+02 >>> > > 0 KSP Residual norm 9.387460484575e+00 >>> > > 1 KSP Residual norm 7.091233040676e-13 >>> > > Line search: gnorm after quadratic fit 3.998857979851e+02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.060972049714e+02 lambda=5.0000000000000003e-02 >>> > > Line search: Cubically determined step, current gnorm >>> 1.512140169420e+02 lambda=5.4338709720680610e-03 >>> > > 12 SNES Function norm 1.512140169420e+02 >>> > > 0 KSP Residual norm 4.399424360499e+00 >>> > > 1 KSP Residual norm 1.614362118182e-13 >>> > > Line search: gnorm after quadratic fit 1.913552832643e+02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.559719302467e+02 lambda=5.0000000000000003e-02 >>> > > Line search: Cubically determined step, current gnorm >>> 1.499985374733e+02 lambda=1.7102027220313589e-02 >>> > > 13 SNES Function norm 1.499985374733e+02 >>> > > 0 KSP Residual norm 3.740397849742e+00 >>> > > 1 KSP Residual norm 8.986775577006e-13 >>> > > Line search: gnorm after quadratic fit 1.764118876632e+02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.522381536119e+02 lambda=4.8196830215713270e-02 >>> > > Line search: Cubically determined step, current gnorm >>> 1.486175880390e+02 lambda=1.8881300948189364e-02 >>> > > 14 SNES Function norm 1.486175880390e+02 >>> > > 0 KSP Residual norm 6.067973818528e+00 >>> > > 1 KSP Residual norm 4.527845229549e-13 >>> > > Line search: gnorm after quadratic fit 2.514021299115e+02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.679972156573e+02 lambda=5.0000000000000003e-02 >>> > > Line search: Cubically determined step, current gnorm >>> 1.481015724304e+02 lambda=9.0116621678703428e-03 >>> > > 15 SNES Function norm 1.481015724304e+02 >>> > > 0 KSP Residual norm 6.108754994263e+00 >>> > > 1 KSP Residual norm 2.557635976440e-13 >>> > > Line search: gnorm after quadratic fit 2.458081150104e+02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.681837029397e+02 lambda=5.0000000000000003e-02 >>> > > Line search: Cubically determined step, current gnorm >>> 1.476148340442e+02 lambda=7.9580911933571953e-03 >>> > > 16 SNES Function norm 1.476148340442e+02 >>> > > 0 KSP Residual norm 7.914946163932e+00 >>> > > 1 KSP Residual norm 1.512066885699e-13 >>> > > Line search: gnorm after quadratic fit 3.458938604598e+02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.883018868359e+02 lambda=5.0000000000000003e-02 >>> > > Line search: Cubically determined step, current gnorm >>> 1.474286108114e+02 lambda=6.7262521208543979e-03 >>> > > 17 SNES Function norm 1.474286108114e+02 >>> > > 0 KSP Residual norm 5.285449532689e+00 >>> > > 1 KSP Residual norm 6.693733977456e-12 >>> > > Line search: gnorm after quadratic fit 2.170263102661e+02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.607560548008e+02 lambda=5.0000000000000003e-02 >>> > > Line search: Cubically determined step, current gnorm >>> 1.467785507822e+02 lambda=9.9244383205188240e-03 >>> > > 18 SNES Function norm 1.467785507822e+02 >>> > > 0 KSP Residual norm 8.124903695635e+00 >>> > > 1 KSP Residual norm 2.322439601127e-11 >>> > > Line search: gnorm after quadratic fit 3.589716592364e+02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.907315184877e+02 lambda=5.0000000000000003e-02 >>> > > Line search: Cubically determined step, current gnorm >>> 1.466341888638e+02 lambda=6.5538271222582893e-03 >>> > > 19 SNES Function norm 1.466341888638e+02 >>> > > 0 KSP Residual norm 5.253550718343e+00 >>> > > 1 KSP Residual norm 1.575657996883e-12 >>> > > Line search: gnorm after quadratic fit 2.155795776725e+02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.598564001687e+02 lambda=5.0000000000000003e-02 >>> > > Line search: Cubically determined step, current gnorm >>> 1.459869404602e+02 lambda=9.9195822632931301e-03 >>> > > 20 SNES Function norm 1.459869404602e+02 >>> > > 0 KSP Residual norm 8.405987790193e+00 >>> > > 1 KSP Residual norm 2.046159481178e-13 >>> > > Line search: gnorm after quadratic fit 3.767908298426e+02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.941885062002e+02 lambda=5.0000000000000003e-02 >>> > > Line search: Cubically determined step, current gnorm >>> 1.458995232755e+02 lambda=6.4359684554015136e-03 >>> > > 21 SNES Function norm 1.458995232755e+02 >>> > > 0 KSP Residual norm 5.036348246593e+00 >>> > > 1 KSP Residual norm 3.645081669075e-13 >>> > > Line search: gnorm after quadratic fit 2.083222977519e+02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.575737508694e+02 lambda=5.0000000000000003e-02 >>> > > Line search: Cubically determined step, current gnorm >>> 1.452039802458e+02 lambda=1.0554092389542354e-02 >>> > > 22 SNES Function norm 1.452039802458e+02 >>> > > 0 KSP Residual norm 8.562292355998e+00 >>> > > 1 KSP Residual norm 3.256332645483e-13 >>> > > Line search: gnorm after quadratic fit 3.869470823355e+02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.959483128249e+02 lambda=5.0000000000000003e-02 >>> > > Line search: Cubically determined step, current gnorm >>> 1.451523830598e+02 lambda=6.3780526507799607e-03 >>> > > 23 SNES Function norm 1.451523830598e+02 >>> > > 0 KSP Residual norm 4.919667503862e+00 >>> > > 1 KSP Residual norm 4.823931177115e-13 >>> > > Line search: gnorm after quadratic fit 2.042891039525e+02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.560623102934e+02 lambda=5.0000000000000003e-02 >>> > > Line search: Cubically determined step, current gnorm >>> 1.444331916523e+02 lambda=1.0890355421223689e-02 >>> > > 24 SNES Function norm 1.444331916523e+02 >>> > > 0 KSP Residual norm 8.727282395369e+00 >>> > > 1 KSP Residual norm 7.090683582186e-13 >>> > > Line search: gnorm after quadratic fit 3.977929422821e+02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.978556223200e+02 lambda=5.0000000000000003e-02 >>> > > Line search: Cubically determined step, current gnorm >>> 1.444215965394e+02 lambda=6.3477766966048947e-03 >>> > > 25 SNES Function norm 1.444215965394e+02 >>> > > 0 KSP Residual norm 4.759732971179e+00 >>> > > 1 KSP Residual norm 7.539889498211e-13 >>> > > Line search: gnorm after quadratic fit 1.990589649135e+02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.542648241555e+02 lambda=5.0000000000000003e-02 >>> > > Line search: Cubically determined step, current gnorm >>> 1.436629416941e+02 lambda=1.1434720389464151e-02 >>> > > 26 SNES Function norm 1.436629416941e+02 >>> > > 0 KSP Residual norm 8.844861828477e+00 >>> > > 1 KSP Residual norm 4.372001279689e-13 >>> > > Line search: gnorm after quadratic fit 4.055598972133e+02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.990820671396e+02 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.436827663113e+02 lambda=6.3302081701296859e-03 >>> > > Line search: Cubically determined step, current gnorm >>> 1.434397789472e+02 lambda=3.1285674619640730e-03 >>> > > 27 SNES Function norm 1.434397789472e+02 >>> > > 0 KSP Residual norm 2.168630760128e+01 >>> > > 1 KSP Residual norm 3.975838928402e-13 >>> > > Line search: gnorm after quadratic fit 1.655681371309e+03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 4.972331169594e+02 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.804118272840e+02 lambda=1.6710557456633125e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.435928635079e+02 lambda=1.6710557456633126e-03 >>> > > Line search: Cubically determined step, current gnorm >>> 1.434032742903e+02 lambda=5.1357350159978810e-04 >>> > > 28 SNES Function norm 1.434032742903e+02 >>> > > 0 KSP Residual norm 5.259508821923e+01 >>> > > 1 KSP Residual norm 1.358381204928e-11 >>> > > Line search: gnorm after quadratic fit 1.908330224731e+04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.431279702545e+03 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 8.060945045253e+02 lambda=2.5000000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.791318323447e+02 lambda=1.2124172979783788e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.491140019897e+02 lambda=2.6952165802905347e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.434246250245e+02 lambda=2.6952165802905350e-04 >>> > > Line search: Cubically determined step, current gnorm >>> 1.433970449422e+02 lambda=8.6980371578986910e-05 >>> > > 29 SNES Function norm 1.433970449422e+02 >>> > > 0 KSP Residual norm 1.326287161615e+02 >>> > > 1 KSP Residual norm 5.692176796134e-12 >>> > > Line search: gnorm after quadratic fit 2.077891749832e+05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.654187989332e+04 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 4.213029457851e+03 lambda=2.5000000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.001385334742e+03 lambda=1.2500000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.323976827250e+02 lambda=5.9607661619885998e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.489839529892e+02 lambda=1.0476257410701045e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.434396736634e+02 lambda=1.0476257410701046e-04 >>> > > Line search: Cubically determined step, current gnorm >>> 1.433960671821e+02 lambda=1.3664867646895530e-05 >>> > > 30 SNES Function norm 1.433960671821e+02 >>> > > 0 KSP Residual norm 3.320710360189e+02 >>> > > 1 KSP Residual norm 1.365660123102e-11 >>> > > Line search: gnorm after quadratic fit 3.597335441013e+06 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 4.714766420450e+05 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 6.566809766217e+04 lambda=2.5000000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.038660363150e+04 lambda=1.2500000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.026997416957e+03 lambda=6.2500000000000003e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 5.382653551072e+02 lambda=3.1250000000000002e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.071747386385e+02 lambda=1.3384948046761360e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.439693866777e+02 lambda=1.3384948046761360e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.434000505249e+02 lambda=1.3384948046761361e-05 >>> > > Line search: Cubically determined step, current gnorm >>> 1.433959111179e+02 lambda=2.1771867000079373e-06 >>> > > 31 SNES Function norm 1.433959111179e+02 >>> > > 0 KSP Residual norm 8.385024273664e+02 >>> > > 1 KSP Residual norm 2.688330817732e-11 >>> > > Line search: gnorm after quadratic fit 5.487352481970e+07 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 6.776642694838e+06 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 8.310551423141e+05 lambda=2.5000000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.023322644608e+05 lambda=1.2500000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.368662233379e+04 lambda=6.2500000000000003e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.472194884015e+03 lambda=3.1250000000000002e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 6.718801059897e+02 lambda=1.5625000000000001e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.274234972424e+02 lambda=6.3064412238487922e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.442194384053e+02 lambda=6.3064412238487925e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.434033578642e+02 lambda=6.3064412238487927e-06 >>> > > Line search: Cubically determined step, current gnorm >>> 1.433959042208e+02 lambda=6.3064412238487929e-07 >>> > > 32 SNES Function norm 1.433959042208e+02 >>> > > 0 KSP Residual norm 5.310191626867e+02 >>> > > 1 KSP Residual norm 2.270033897601e-10 >>> > > Line search: gnorm after quadratic fit 1.447633783740e+07 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.859761774309e+06 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.472992503503e+05 lambda=2.5000000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.557594026810e+04 lambda=1.2500000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 5.969012939380e+03 lambda=6.2500000000000003e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.269212161982e+03 lambda=3.1250000000000002e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.859005100842e+02 lambda=1.5625000000000001e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.695095262046e+02 lambda=5.4509037994531233e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.436389958907e+02 lambda=5.4509037994531237e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.433976258223e+02 lambda=5.4509037994531242e-06 >>> > > Line search: Cubically determined step, current gnorm >>> 1.433958431980e+02 lambda=8.5124820362933632e-07 >>> > > 33 SNES Function norm 1.433958431980e+02 >>> > > 0 KSP Residual norm 1.341142541825e+03 >>> > > 1 KSP Residual norm 4.194815344365e-11 >>> > > Line search: gnorm after quadratic fit 2.256410317099e+08 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.797696259877e+07 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.447237377751e+06 lambda=2.5000000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 4.221898175722e+05 lambda=1.2500000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 5.260244723327e+04 lambda=6.2500000000000003e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 7.539148524881e+03 lambda=3.1250000000000002e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.558034531173e+03 lambda=1.5625000000000001e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 4.788188892302e+02 lambda=7.8125000000000004e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.753621043454e+02 lambda=2.4427125599600652e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.437122397600e+02 lambda=2.4427125599600654e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.433986985128e+02 lambda=2.4427125599600655e-06 >>> > > Line search: Cubically determined step, current gnorm >>> 1.433958402293e+02 lambda=2.4427125599600656e-07 >>> > > 34 SNES Function norm 1.433958402293e+02 >>> > > 0 KSP Residual norm 8.620962950418e+02 >>> > > 1 KSP Residual norm 4.517777375659e-11 >>> > > Line search: gnorm after quadratic fit 6.134442313460e+07 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 7.790495969255e+06 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.008365220843e+06 lambda=2.5000000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.364572513478e+05 lambda=1.2500000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.037891335918e+04 lambda=6.2500000000000003e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.640571521199e+03 lambda=3.1250000000000002e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 8.472549649319e+02 lambda=1.5625000000000001e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.906041216274e+02 lambda=7.6348458761785112e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.504925859329e+02 lambda=1.7740973415567094e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.434632637071e+02 lambda=1.7740973415567094e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.433962847027e+02 lambda=1.7740973415567095e-06 >>> > > Line search: Cubically determined step, current gnorm >>> 1.433958170795e+02 lambda=3.2293255704969003e-07 >>> > > 35 SNES Function norm 1.433958170795e+02 >>> > > 0 KSP Residual norm 2.177497039945e+03 >>> > > 1 KSP Residual norm 8.546235181505e-11 >>> > > Line search: gnorm after quadratic fit 9.689178330938e+08 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.204850731541e+08 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.491460480376e+07 lambda=2.5000000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.833699292784e+06 lambda=1.2500000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.246639021599e+05 lambda=6.2500000000000003e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.860166571872e+04 lambda=3.1250000000000002e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 4.484329051490e+03 lambda=1.5625000000000001e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.050411687443e+03 lambda=7.8125000000000004e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.488366972009e+02 lambda=3.7767265396089055e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.508326035050e+02 lambda=7.2725649346261757e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.434696063559e+02 lambda=7.2725649346261764e-06 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.433964618996e+02 lambda=7.2725649346261768e-07 >>> > > Line search: Cubically determined step, current gnorm >>> 1.433958141405e+02 lambda=7.2725649346261771e-08 >>> > > 36 SNES Function norm 1.433958141405e+02 >>> > > 0 KSP Residual norm 2.164813477994e+03 >>> > > 1 KSP Residual norm 1.148881458292e-10 >>> > > Line search: gnorm after quadratic fit 9.626940870744e+08 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.210459267934e+08 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.531855101756e+07 lambda=2.5000000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.966826097072e+06 lambda=1.2500000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.611808255272e+05 lambda=6.2500000000000003e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.746062783262e+04 lambda=3.1250000000000002e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 6.252259871244e+03 lambda=1.5625000000000001e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.319447372021e+03 lambda=7.8125000000000004e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.963055448218e+02 lambda=3.9062500000000002e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.719034797105e+02 lambda=1.3935000445038475e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.436664111092e+02 lambda=1.3935000445038476e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.433983336239e+02 lambda=1.3935000445038476e-06 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.433958213497e+02 lambda=1.3935000445038476e-07 >>> > > Line search: Cubically determined step, current gnorm >>> 1.433958104705e+02 lambda=5.1202466521517630e-08 >>> > > 37 SNES Function norm 1.433958104705e+02 >>> > > 0 KSP Residual norm 5.470482746849e+03 >>> > > 1 KSP Residual norm 2.077456833170e-10 >>> > > Line search: gnorm after quadratic fit 1.541335606193e+10 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.922526157954e+09 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.393079394383e+08 lambda=2.5000000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.967573549050e+07 lambda=1.2500000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.657319925168e+06 lambda=6.2500000000000003e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 4.479516204895e+05 lambda=3.1250000000000002e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 5.573399122917e+04 lambda=1.5625000000000001e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 7.931177424479e+03 lambda=7.8125000000000004e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.619710606187e+03 lambda=3.9062500000000002e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 4.924551713717e+02 lambda=1.9531250000000001e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.786095404459e+02 lambda=6.2808469554243522e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.437467476469e+02 lambda=6.2808469554243527e-06 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.433992463439e+02 lambda=6.2808469554243527e-07 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.433958367271e+02 lambda=6.2808469554243525e-08 >>> > > Line search: Cubically determined step, current gnorm >>> 1.433958098948e+02 lambda=8.0208105170108588e-09 >>> > > 38 SNES Function norm 1.433958098948e+02 >>> > > 0 KSP Residual norm 1.380568582849e+04 >>> > > 1 KSP Residual norm 3.830866223513e-10 >>> > > Line search: gnorm after quadratic fit 2.484973518314e+11 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.108953896984e+10 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.893104137528e+09 lambda=2.5000000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 4.884003910853e+08 lambda=1.2500000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 6.150765563542e+07 lambda=6.2500000000000003e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 7.811161146103e+06 lambda=3.1250000000000002e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.011017986781e+06 lambda=1.5625000000000001e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.368084343451e+05 lambda=7.8125000000000004e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.042876665700e+04 lambda=3.9062500000000002e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.648735196752e+03 lambda=1.9531250000000001e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 8.489051252413e+02 lambda=9.7656250000000005e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.910677756717e+02 lambda=4.7728537787817724e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.505452645186e+02 lambda=1.1099980464343249e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.434658984864e+02 lambda=1.1099980464343249e-06 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.433964956476e+02 lambda=1.1099980464343249e-07 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.433958153212e+02 lambda=1.1099980464343250e-08 >>> > > Line search: Cubically determined step, current gnorm >>> 1.433958098048e+02 lambda=1.2587012037197021e-09 >>> > > 39 SNES Function norm 1.433958098048e+02 >>> > > 0 KSP Residual norm 3.492284741552e+04 >>> > > 1 KSP Residual norm 2.459788921244e-09 >>> > > Line search: gnorm after quadratic fit 4.017424324975e+12 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 5.020053801097e+11 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 6.270768402853e+10 lambda=2.5000000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 7.827801904036e+09 lambda=1.2500000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 9.758550488105e+08 lambda=6.2500000000000003e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.213492627852e+08 lambda=3.1250000000000002e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.502191365805e+07 lambda=1.5625000000000001e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.846947104704e+06 lambda=7.8125000000000004e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.262850216093e+05 lambda=3.9062500000000002e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.879926646684e+04 lambda=1.9531250000000001e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 4.510203332079e+03 lambda=9.7656250000000005e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.055028679619e+03 lambda=4.8828125000000003e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.503903269554e+02 lambda=2.3633949212111800e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.510245991472e+02 lambda=4.5897967908360529e-06 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.434724062782e+02 lambda=4.5897967908360533e-07 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.433965706606e+02 lambda=4.5897967908360533e-08 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.433958168196e+02 lambda=4.5897967908360538e-09 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.433958098155e+02 lambda=4.5897967908360540e-10 >>> > > Line search: Cubically determined step, current gnorm >>> 1.433958097906e+02 lambda=1.9745369723997599e-10 >>> > > 40 SNES Function norm 1.433958097906e+02 >>> > > 0 KSP Residual norm 8.722495521587e+04 >>> > > 1 KSP Residual norm 3.742695919275e-09 >>> > > Line search: gnorm after quadratic fit 6.262538457180e+13 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 7.829256308992e+12 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 9.789282877890e+11 lambda=2.5000000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.224340679566e+11 lambda=1.2500000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.532137613500e+10 lambda=6.2500000000000003e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.919506047737e+09 lambda=3.1250000000000002e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.410488718338e+08 lambda=1.5625000000000001e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.042211373104e+07 lambda=7.8125000000000004e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.881986305609e+06 lambda=3.9062500000000002e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 5.080857001861e+05 lambda=1.9531250000000001e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 7.054449734307e+04 lambda=9.7656250000000005e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.109051581397e+04 lambda=4.8828125000000003e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.144985497099e+03 lambda=2.4414062500000001e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 5.617627947761e+02 lambda=1.2207031250000001e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.132828960986e+02 lambda=5.3137869181552773e-06 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.440403409760e+02 lambda=5.3137869181552777e-07 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.434022226216e+02 lambda=5.3137869181552781e-08 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.433958732177e+02 lambda=5.3137869181552781e-09 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.433958103569e+02 lambda=5.3137869181552779e-10 >>> > > Line search: Cubically determined step, current gnorm >>> 1.433958097894e+02 lambda=5.3137869181552781e-11 >>> > > 41 SNES Function norm 1.433958097894e+02 >>> > > 0 KSP Residual norm 6.453169081212e+04 >>> > > 1 KSP Residual norm 2.762540688686e-09 >>> > > Line search: gnorm after quadratic fit 2.535166112592e+13 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.168366990040e+12 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.958985371462e+11 lambda=2.5000000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 4.945064622488e+10 lambda=1.2500000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 6.172244865713e+09 lambda=6.2500000000000003e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 7.693002384290e+08 lambda=3.1250000000000002e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 9.562568994785e+07 lambda=1.5625000000000001e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.182957296890e+07 lambda=7.8125000000000004e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.453260254263e+06 lambda=3.9062500000000002e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.781984147743e+05 lambda=1.9531250000000001e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.294934468515e+04 lambda=9.7656250000000005e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.740461720782e+03 lambda=4.8828125000000003e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 9.162621855154e+02 lambda=2.4414062500000001e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.042417294890e+02 lambda=1.1290474210136388e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.458920680477e+02 lambda=1.4201366604660443e-06 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.434208620254e+02 lambda=1.4201366604660444e-07 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.433960586269e+02 lambda=1.4201366604660445e-08 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.433958120934e+02 lambda=1.4201366604660445e-09 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.433958097940e+02 lambda=1.4201366604660446e-10 >>> > > Line search: Cubically determined step, current gnorm >>> 1.433958097852e+02 lambda=5.7981795207229486e-11 >>> > > 42 SNES Function norm 1.433958097852e+02 >>> > > 0 KSP Residual norm 1.596625793747e+05 >>> > > 1 KSP Residual norm 6.465899717071e-09 >>> > > Line search: gnorm after quadratic fit 3.840699863976e+14 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 4.801237514773e+13 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 6.002454410823e+12 lambda=2.5000000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 7.505340831651e+11 lambda=1.2500000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 9.387378188418e+10 lambda=6.2500000000000003e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.174857842415e+10 lambda=3.1250000000000002e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.472211181784e+09 lambda=1.5625000000000001e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.849608933788e+08 lambda=7.8125000000000004e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.336592011613e+07 lambda=3.9062500000000002e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.988079805895e+06 lambda=1.9531250000000001e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.930858080425e+05 lambda=9.7656250000000005e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 5.521190722497e+04 lambda=4.8828125000000003e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 8.872153015323e+03 lambda=2.4414062500000001e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.772337662956e+03 lambda=1.2207031250000001e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 4.879470852054e+02 lambda=6.1035156250000003e-06 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.942774855488e+02 lambda=2.4957912736226801e-06 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.438719078958e+02 lambda=2.4957912736226800e-07 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.434005516391e+02 lambda=2.4957912736226800e-08 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.433958568732e+02 lambda=2.4957912736226803e-09 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.433958102244e+02 lambda=2.4957912736226804e-10 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.433958097865e+02 lambda=2.4957912736226805e-11 >>> > > Line search: Cubically determined step, current gnorm >>> 1.433958097846e+02 lambda=9.2900433293108317e-12 >>> > > 43 SNES Function norm 1.433958097846e+02 >>> > > 0 KSP Residual norm 4.230869747157e+05 >>> > > 1 KSP Residual norm 2.238707423027e-08 >>> > > Line search: gnorm after quadratic fit 7.145700515048e+15 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 8.931871281700e+14 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.116420341041e+14 lambda=2.5000000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.395366610168e+13 lambda=1.2500000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.743811756566e+12 lambda=6.2500000000000003e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.178776103292e+11 lambda=3.1250000000000002e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.721012032848e+10 lambda=1.5625000000000001e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.395186924428e+09 lambda=7.8125000000000004e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 4.229125978585e+08 lambda=3.9062500000000002e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 5.250971135953e+07 lambda=1.9531250000000001e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 6.483856203094e+06 lambda=9.7656250000000005e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 7.950671355228e+05 lambda=4.8828125000000003e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 9.795408218555e+04 lambda=2.4414062500000001e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.315025696280e+04 lambda=1.2207031250000001e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.395961070555e+03 lambda=6.1035156250000003e-06 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 6.565070307576e+02 lambda=3.0517578125000002e-06 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.228949713871e+02 lambda=1.2154989071946628e-06 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.441831998014e+02 lambda=1.2154989071946629e-07 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.434037055996e+02 lambda=1.2154989071946630e-08 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.433958886074e+02 lambda=1.2154989071946630e-09 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.433958105564e+02 lambda=1.2154989071946630e-10 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.433958097907e+02 lambda=1.2154989071946631e-11 >>> > > Line search: Cubically determined step, current gnorm >>> 1.433958097845e+02 lambda=1.3559489351735629e-12 >>> > > 44 SNES Function norm 1.433958097845e+02 >>> > > 0 KSP Residual norm 1.017589039922e+06 >>> > > 1 KSP Residual norm 5.483283808994e-08 >>> > > Line search: gnorm after quadratic fit 9.942386816509e+16 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.242813073279e+16 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.553553149772e+15 lambda=2.5000000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.942033483320e+14 lambda=1.2500000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.427772097758e+13 lambda=6.2500000000000003e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.035291372732e+12 lambda=3.1250000000000002e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.795558047824e+11 lambda=1.5625000000000001e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 4.748073147307e+10 lambda=7.8125000000000004e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 5.944235240368e+09 lambda=3.9062500000000002e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 7.453550734860e+08 lambda=1.9531250000000001e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 9.377045707707e+07 lambda=9.7656250000000005e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.188119937132e+07 lambda=4.8828125000000003e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.529730353136e+06 lambda=2.4414062500000001e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.044646611329e+05 lambda=1.2207031250000001e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.974477616118e+04 lambda=6.1035156250000003e-06 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 5.087923877078e+03 lambda=3.0517578125000002e-06 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.112257173311e+03 lambda=1.5258789062500001e-06 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.536190077033e+02 lambda=7.6293945312500004e-07 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.622567424729e+02 lambda=2.4244966960965791e-07 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.435780438142e+02 lambda=2.4244966960965793e-08 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.433976282603e+02 lambda=2.4244966960965796e-09 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.433958279382e+02 lambda=2.4244966960965797e-10 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.433958099632e+02 lambda=2.4244966960965799e-11 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.433958097860e+02 lambda=2.4244966960965801e-12 >>> > > Line search: Cubically determined step, current gnorm >>> 1.433958097845e+02 lambda=2.4244966960965801e-13 >>> > > 45 SNES Function norm 1.433958097845e+02 >>> > > 0 KSP Residual norm 2.206687220910e+06 >>> > > 1 KSP Residual norm 4.897651438902e-08 >>> > > Line search: gnorm after quadratic fit 1.013883843512e+18 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.267347883019e+17 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.584167551460e+16 lambda=2.5000000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.980166189110e+15 lambda=1.2500000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.475099638694e+14 lambda=6.2500000000000003e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.093604443378e+13 lambda=3.1250000000000002e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.866330988164e+12 lambda=1.5625000000000001e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 4.831230804145e+11 lambda=7.8125000000000004e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 6.034848618023e+10 lambda=3.9062500000000002e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 7.533173457427e+09 lambda=1.9531250000000001e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 9.390937545910e+08 lambda=9.7656250000000005e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.167706366282e+08 lambda=4.8828125000000003e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.445357932595e+07 lambda=2.4414062500000001e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.776833600920e+06 lambda=1.2207031250000001e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.177171496134e+05 lambda=6.1035156250000003e-06 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.775750596740e+04 lambda=3.0517578125000002e-06 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 4.374283858049e+03 lambda=1.5258789062500001e-06 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.030949543491e+03 lambda=7.6293945312500004e-07 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.423064811256e+02 lambda=3.6673216108643130e-07 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.499924205417e+02 lambda=6.7541706529544844e-08 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.434620968378e+02 lambda=6.7541706529544851e-09 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.433964732224e+02 lambda=6.7541706529544853e-10 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.433958164087e+02 lambda=6.7541706529544856e-11 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.433958098496e+02 lambda=6.7541706529544860e-12 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.433958097850e+02 lambda=6.7541706529544869e-13 >>> > > Line search: unable to find good step length! After 24 tries >>> > > Line search: fnorm=1.4339580978447020e+02, >>> gnorm=1.4339580978501337e+02, ynorm=2.2066872446260620e+06, >>> minlambda=9.9999999999999998e-13, lambda=6.7541706529544869e-13, >>> initial slope=-2.0562359199040133e+04 >>> > > 0 SNES Function norm 7.494832241120e+03 >>> > > 0 KSP Residual norm 2.096735360816e+01 >>> > > 1 KSP Residual norm 1.310027756820e-12 >>> > > Line search: gnorm after quadratic fit 6.728375857515e+03 >>> > > Line search: Quadratically determined step, >>> lambda=1.0000000000000001e-01 >>> > > 1 SNES Function norm 6.728375857515e+03 >>> > > 0 KSP Residual norm 2.051806116405e+01 >>> > > 1 KSP Residual norm 4.624620138831e-13 >>> > > Line search: gnorm after quadratic fit 6.028616261650e+03 >>> > > Line search: Quadratically determined step, >>> lambda=1.0000000000000001e-01 >>> > > 2 SNES Function norm 6.028616261650e+03 >>> > > 0 KSP Residual norm 2.416503160016e+01 >>> > > 1 KSP Residual norm 8.456041680630e-13 >>> > > Line search: gnorm after quadratic fit 5.407473517447e+03 >>> > > Line search: Quadratically determined step, >>> lambda=1.0000000000000001e-01 >>> > > 3 SNES Function norm 5.407473517447e+03 >>> > > 0 KSP Residual norm 1.429873750399e+01 >>> > > 1 KSP Residual norm 2.956316145819e-13 >>> > > Line search: Using full step: fnorm 5.407473517447e+03 gnorm >>> 1.894530516076e+03 >>> > > 4 SNES Function norm 1.894530516076e+03 >>> > > 0 KSP Residual norm 2.898580554597e+00 >>> > > 1 KSP Residual norm 6.622560162623e-14 >>> > > Line search: Using full step: fnorm 1.894530516076e+03 gnorm >>> 1.794029421846e+03 >>> > > 5 SNES Function norm 1.794029421846e+03 >>> > > 0 KSP Residual norm 1.749678611959e+01 >>> > > 1 KSP Residual norm 8.138905825078e-12 >>> > > Line search: gnorm after quadratic fit 1.767361408940e+03 >>> > > Line search: Quadratically determined step, >>> lambda=1.0000000000000001e-01 >>> > > 6 SNES Function norm 1.767361408940e+03 >>> > > 0 KSP Residual norm 1.094404109423e+02 >>> > > 1 KSP Residual norm 7.696691527700e-12 >>> > > Line search: gnorm after quadratic fit 3.545750923895e+04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 6.153479540314e+03 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.205683629874e+03 lambda=2.5000000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.802976525485e+03 lambda=1.2441094586006883e-02 >>> > > Line search: Cubically determined step, current gnorm >>> 1.765063299263e+03 lambda=4.9240328094708914e-03 >>> > > 7 SNES Function norm 1.765063299263e+03 >>> > > 0 KSP Residual norm 1.778095975189e+01 >>> > > 1 KSP Residual norm 2.814661813934e-12 >>> > > Line search: gnorm after quadratic fit 2.620761680117e+03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.793045753271e+03 lambda=5.0000000000000003e-02 >>> > > Line search: Cubically determined step, current gnorm >>> 1.740299227935e+03 lambda=2.5000000000000001e-02 >>> > > 8 SNES Function norm 1.740299227935e+03 >>> > > 0 KSP Residual norm 3.284236894535e+02 >>> > > 1 KSP Residual norm 5.172103783952e-10 >>> > > Line search: gnorm after quadratic fit 2.857820523902e+05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 4.063993491139e+04 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 7.588139591650e+03 lambda=2.5000000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.491163684413e+03 lambda=1.2500000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.802614760566e+03 lambda=5.7977212395253904e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.741444490992e+03 lambda=1.8448315876950813e-03 >>> > > Line search: Cubically determined step, current gnorm >>> 1.739663656043e+03 lambda=7.7468345598227730e-04 >>> > > 9 SNES Function norm 1.739663656043e+03 >>> > > 0 KSP Residual norm 4.581839103558e+02 >>> > > 1 KSP Residual norm 2.627035885943e-11 >>> > > Line search: gnorm after quadratic fit 8.199478499066e+05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.127270076812e+05 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.816774161281e+04 lambda=2.5000000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 4.053723877333e+03 lambda=1.2500000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.971814513392e+03 lambda=6.2500000000000003e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.755066208174e+03 lambda=2.7232010924558834e-03 >>> > > Line search: Cubically determined step, current gnorm >>> 1.739559834479e+03 lambda=8.1458417855297680e-04 >>> > > 10 SNES Function norm 1.739559834479e+03 >>> > > 0 KSP Residual norm 1.463056810139e+02 >>> > > 1 KSP Residual norm 5.383584598825e-12 >>> > > Line search: gnorm after quadratic fit 2.885699620595e+04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 5.847717401708e+03 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.244464170034e+03 lambda=2.5000000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.769157604338e+03 lambda=1.0857209099577540e-02 >>> > > Line search: Cubically determined step, current gnorm >>> 1.737356225452e+03 lambda=4.0312937622950231e-03 >>> > > 11 SNES Function norm 1.737356225452e+03 >>> > > 0 KSP Residual norm 1.564105677925e+02 >>> > > 1 KSP Residual norm 6.671164745832e-11 >>> > > Line search: gnorm after quadratic fit 3.815800291873e+04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 7.197027796134e+03 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.373151605545e+03 lambda=2.5000000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.783976520867e+03 lambda=1.2093374970461970e-02 >>> > > Line search: Cubically determined step, current gnorm >>> 1.735737929915e+03 lambda=4.9529698477569920e-03 >>> > > 12 SNES Function norm 1.735737929915e+03 >>> > > 0 KSP Residual norm 5.030757139645e+01 >>> > > 1 KSP Residual norm 1.157542730692e-12 >>> > > Line search: gnorm after quadratic fit 3.004544441458e+03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.850403239750e+03 lambda=5.0000000000000003e-02 >>> > > Line search: Cubically determined step, current gnorm >>> 1.722893188305e+03 lambda=2.0881992439921702e-02 >>> > > 13 SNES Function norm 1.722893188305e+03 >>> > > 0 KSP Residual norm 7.123428853845e+01 >>> > > 1 KSP Residual norm 8.671726774894e-12 >>> > > Line search: gnorm after quadratic fit 4.361041499279e+03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.032697222107e+03 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.726212330814e+03 lambda=1.9909470348267504e-02 >>> > > Line search: Cubically determined step, current gnorm >>> 1.714127356920e+03 lambda=9.9547351741337518e-03 >>> > > 14 SNES Function norm 1.714127356920e+03 >>> > > 0 KSP Residual norm 8.304557447257e+00 >>> > > 1 KSP Residual norm 6.268295862688e-13 >>> > > Line search: gnorm after quadratic fit 1.558163002487e+03 >>> > > Line search: Quadratically determined step, >>> lambda=1.0000000000000001e-01 >>> > > 15 SNES Function norm 1.558163002487e+03 >>> > > 0 KSP Residual norm 2.820803287164e+00 >>> > > 1 KSP Residual norm 5.477413853752e-13 >>> > > Line search: gnorm after quadratic fit 1.065673478530e+03 >>> > > Line search: Quadratically determined step, >>> lambda=3.8943438938591052e-01 >>> > > 16 SNES Function norm 1.065673478530e+03 >>> > > 0 KSP Residual norm 2.296739120664e+00 >>> > > 1 KSP Residual norm 6.273731899885e-14 >>> > > Line search: gnorm after quadratic fit 8.964342150621e+02 >>> > > Line search: Quadratically determined step, >>> lambda=1.8740736900935545e-01 >>> > > 17 SNES Function norm 8.964342150621e+02 >>> > > 0 KSP Residual norm 5.567568505830e+00 >>> > > 1 KSP Residual norm 8.649083600764e-12 >>> > > Line search: gnorm after quadratic fit 8.322514858992e+02 >>> > > Line search: Quadratically determined step, >>> lambda=1.0000000000000001e-01 >>> > > 18 SNES Function norm 8.322514858992e+02 >>> > > 0 KSP Residual norm 1.164393577210e+00 >>> > > 1 KSP Residual norm 2.019248309015e-14 >>> > > Line search: Using full step: fnorm 8.322514858992e+02 gnorm >>> 3.179750274746e+02 >>> > > 19 SNES Function norm 3.179750274746e+02 >>> > > 0 KSP Residual norm 5.339294310641e+00 >>> > > 1 KSP Residual norm 2.070321587238e-13 >>> > > Line search: gnorm after quadratic fit 3.433012316833e+02 >>> > > Line search: Cubically determined step, current gnorm >>> 3.140305403821e+02 lambda=5.0000000000000003e-02 >>> > > 20 SNES Function norm 3.140305403821e+02 >>> > > 0 KSP Residual norm 1.177016565578e+01 >>> > > 1 KSP Residual norm 2.413027540446e-13 >>> > > Line search: gnorm after quadratic fit 7.377851778409e+02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.896721016582e+02 lambda=5.0000000000000003e-02 >>> > > Line search: Cubically determined step, current gnorm >>> 3.136619309181e+02 lambda=9.7219892278716195e-03 >>> > > 21 SNES Function norm 3.136619309181e+02 >>> > > 0 KSP Residual norm 3.973565083977e+00 >>> > > 1 KSP Residual norm 9.726786674410e-14 >>> > > Line search: gnorm after quadratic fit 3.098277326090e+02 >>> > > Line search: Quadratically determined step, >>> lambda=1.0000000000000001e-01 >>> > > 22 SNES Function norm 3.098277326090e+02 >>> > > 0 KSP Residual norm 9.389290683519e+00 >>> > > 1 KSP Residual norm 1.651497163724e-13 >>> > > Line search: gnorm after quadratic fit 6.887970540455e+02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.588146381477e+02 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.099274823603e+02 lambda=1.6890426151283184e-02 >>> > > Line search: Cubically determined step, current gnorm >>> 3.084890760827e+02 lambda=8.4452130756415920e-03 >>> > > 23 SNES Function norm 3.084890760827e+02 >>> > > 0 KSP Residual norm 2.381130479641e+00 >>> > > 1 KSP Residual norm 4.694489283156e-14 >>> > > Line search: gnorm after quadratic fit 2.872151876535e+02 >>> > > Line search: Quadratically determined step, >>> lambda=1.0000000000000001e-01 >>> > > 24 SNES Function norm 2.872151876535e+02 >>> > > 0 KSP Residual norm 2.405498502269e+00 >>> > > 1 KSP Residual norm 3.316846070538e-13 >>> > > Line search: gnorm after quadratic fit 2.686789761232e+02 >>> > > Line search: Quadratically determined step, >>> lambda=1.0000000000000001e-01 >>> > > 25 SNES Function norm 2.686789761232e+02 >>> > > 0 KSP Residual norm 1.728772970554e+00 >>> > > 1 KSP Residual norm 4.132974383339e-14 >>> > > Line search: gnorm after quadratic fit 2.365009918229e+02 >>> > > Line search: Quadratically determined step, >>> lambda=1.7273357529379074e-01 >>> > > 26 SNES Function norm 2.365009918229e+02 >>> > > 0 KSP Residual norm 4.413764759374e+00 >>> > > 1 KSP Residual norm 5.210690816917e-14 >>> > > Line search: gnorm after quadratic fit 2.756730968257e+02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.372321757171e+02 lambda=5.0000000000000003e-02 >>> > > Line search: Cubically determined step, current gnorm >>> 2.335020811250e+02 lambda=2.5000000000000001e-02 >>> > > 27 SNES Function norm 2.335020811250e+02 >>> > > 0 KSP Residual norm 1.606246507553e+00 >>> > > 1 KSP Residual norm 3.564847846678e-14 >>> > > Line search: gnorm after quadratic fit 2.078263630653e+02 >>> > > Line search: Quadratically determined step, >>> lambda=1.5913860995949433e-01 >>> > > 28 SNES Function norm 2.078263630653e+02 >>> > > 0 KSP Residual norm 3.700632954873e+00 >>> > > 1 KSP Residual norm 5.113863400264e-13 >>> > > Line search: gnorm after quadratic fit 2.142503514807e+02 >>> > > Line search: Cubically determined step, current gnorm >>> 2.021095009118e+02 lambda=5.0000000000000003e-02 >>> > > 29 SNES Function norm 2.021095009118e+02 >>> > > 0 KSP Residual norm 3.056449560135e+00 >>> > > 1 KSP Residual norm 3.207987681334e-14 >>> > > Line search: gnorm after quadratic fit 2.064252530802e+02 >>> > > Line search: Cubically determined step, current gnorm >>> 1.978069081639e+02 lambda=5.0000000000000003e-02 >>> > > 30 SNES Function norm 1.978069081639e+02 >>> > > 0 KSP Residual norm 2.024695620703e+00 >>> > > 1 KSP Residual norm 5.460360737995e-14 >>> > > Line search: gnorm after quadratic fit 1.839556530796e+02 >>> > > Line search: Quadratically determined step, >>> lambda=1.0000000000000001e-01 >>> > > 31 SNES Function norm 1.839556530796e+02 >>> > > 0 KSP Residual norm 1.610676619931e+01 >>> > > 1 KSP Residual norm 6.703552136307e-13 >>> > > Line search: gnorm after quadratic fit 7.186735314913e+02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.905672430097e+02 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.856766286600e+02 lambda=1.0830798014298563e-02 >>> > > Line search: Cubically determined step, current gnorm >>> 1.836818937131e+02 lambda=3.3207362501459785e-03 >>> > > 32 SNES Function norm 1.836818937131e+02 >>> > > 0 KSP Residual norm 7.471722173131e+01 >>> > > 1 KSP Residual norm 2.671534648829e-12 >>> > > Line search: gnorm after quadratic fit 9.613379909411e+04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.509491298762e+04 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.808861367705e+03 lambda=2.5000000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 6.767283758299e+02 lambda=1.2500000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.665421328348e+02 lambda=6.0369453941238101e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.869726717041e+02 lambda=1.4394327006264963e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.836897704575e+02 lambda=1.4394327006264963e-04 >>> > > Line search: Cubically determined step, current gnorm >>> 1.836767951408e+02 lambda=5.5567420418543164e-05 >>> > > 33 SNES Function norm 1.836767951408e+02 >>> > > 0 KSP Residual norm 2.702367712138e+01 >>> > > 1 KSP Residual norm 2.731656687850e-12 >>> > > Line search: gnorm after quadratic fit 3.331563146098e+03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 8.723694790688e+02 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.941243220944e+02 lambda=2.1443568774664485e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.847231733910e+02 lambda=2.7571330376860012e-03 >>> > > Line search: Cubically determined step, current gnorm >>> 1.836356729409e+02 lambda=4.7841280418270480e-04 >>> > > 34 SNES Function norm 1.836356729409e+02 >>> > > 0 KSP Residual norm 1.228333177997e+01 >>> > > 1 KSP Residual norm 2.681127387880e-13 >>> > > Line search: gnorm after quadratic fit 6.936329223475e+02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.749327218775e+02 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.871557327742e+02 lambda=1.4160505301999991e-02 >>> > > Line search: Cubically determined step, current gnorm >>> 1.833523080682e+02 lambda=3.5196326548579192e-03 >>> > > 35 SNES Function norm 1.833523080682e+02 >>> > > 0 KSP Residual norm 3.531886257396e+02 >>> > > 1 KSP Residual norm 2.364634092895e-11 >>> > > Line search: gnorm after quadratic fit 3.994783047929e+06 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 4.753715960726e+05 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 5.516669898185e+04 lambda=2.5000000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 6.918985942348e+03 lambda=1.2500000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.363599250418e+03 lambda=6.2500000000000003e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 4.344906818752e+02 lambda=3.1250000000000002e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.991088183980e+02 lambda=1.0108094710462592e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.834621681844e+02 lambda=1.0108094710462593e-04 >>> > > Line search: Cubically determined step, current gnorm >>> 1.833517377324e+02 lambda=1.0108094710462594e-05 >>> > > 36 SNES Function norm 1.833517377324e+02 >>> > > 0 KSP Residual norm 9.005833507118e+01 >>> > > 1 KSP Residual norm 6.116387880629e-12 >>> > > Line search: gnorm after quadratic fit 8.899847103226e+04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.388111536526e+04 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.532652074749e+03 lambda=2.5000000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 5.864912734009e+02 lambda=1.2500000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.421068789960e+02 lambda=6.2500000000000003e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.873498120960e+02 lambda=2.1924025345283278e-03 >>> > > Line search: Cubically determined step, current gnorm >>> 1.833506987706e+02 lambda=2.1924025345283280e-04 >>> > > 37 SNES Function norm 1.833506987706e+02 >>> > > 0 KSP Residual norm 1.548426525207e+01 >>> > > 1 KSP Residual norm 1.038038773942e-12 >>> > > Line search: gnorm after quadratic fit 6.702848665441e+02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.789880616078e+02 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.846521504351e+02 lambda=1.0567302644323170e-02 >>> > > Line search: Cubically determined step, current gnorm >>> 1.830548481815e+02 lambda=3.5274490352771972e-03 >>> > > 38 SNES Function norm 1.830548481815e+02 >>> > > 0 KSP Residual norm 1.523095478807e+01 >>> > > 1 KSP Residual norm 1.963823596119e-12 >>> > > Line search: gnorm after quadratic fit 9.255727478491e+02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.496757253461e+02 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.863126241242e+02 lambda=9.3143291632966311e-03 >>> > > Line search: Cubically determined step, current gnorm >>> 1.829091761403e+02 lambda=1.8107234819462800e-03 >>> > > 39 SNES Function norm 1.829091761403e+02 >>> > > 0 KSP Residual norm 1.311320726934e+01 >>> > > 1 KSP Residual norm 9.084170520902e-13 >>> > > Line search: gnorm after quadratic fit 7.488610069188e+02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.691148243365e+02 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.885558228772e+02 lambda=1.9439894235886539e-02 >>> > > Line search: Cubically determined step, current gnorm >>> 1.825540619134e+02 lambda=5.4967824488704169e-03 >>> > > 40 SNES Function norm 1.825540619134e+02 >>> > > 0 KSP Residual norm 1.218635557505e+01 >>> > > 1 KSP Residual norm 7.760485728617e-13 >>> > > Line search: gnorm after quadratic fit 6.636453826807e+02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.880828006022e+02 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.830493790584e+02 lambda=6.6234802648049863e-03 >>> > > Line search: Cubically determined step, current gnorm >>> 1.823397545268e+02 lambda=2.4308217464828865e-03 >>> > > 41 SNES Function norm 1.823397545268e+02 >>> > > 0 KSP Residual norm 9.456543593865e+00 >>> > > 1 KSP Residual norm 7.046593270309e-13 >>> > > Line search: gnorm after quadratic fit 3.369769163110e+02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.105230957789e+02 lambda=5.0000000000000003e-02 >>> > > Line search: Cubically determined step, current gnorm >>> 1.817897533119e+02 lambda=9.1612481372917148e-03 >>> > > 42 SNES Function norm 1.817897533119e+02 >>> > > 0 KSP Residual norm 7.290035145805e+00 >>> > > 1 KSP Residual norm 3.198962158141e-12 >>> > > Line search: gnorm after quadratic fit 2.858311567415e+02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.965004842981e+02 lambda=5.0000000000000003e-02 >>> > > Line search: Cubically determined step, current gnorm >>> 1.808845577764e+02 lambda=1.3826421990147811e-02 >>> > > 43 SNES Function norm 1.808845577764e+02 >>> > > 0 KSP Residual norm 7.256785036157e+00 >>> > > 1 KSP Residual norm 9.243179217625e-14 >>> > > Line search: gnorm after quadratic fit 2.534388176390e+02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.916726818893e+02 lambda=5.0000000000000003e-02 >>> > > Line search: Cubically determined step, current gnorm >>> 1.797953125543e+02 lambda=1.3677747819164022e-02 >>> > > 44 SNES Function norm 1.797953125543e+02 >>> > > 0 KSP Residual norm 1.716201096352e+01 >>> > > 1 KSP Residual norm 2.701418800808e-13 >>> > > Line search: gnorm after quadratic fit 1.331064301474e+03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 4.461842246267e+02 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.920668830294e+02 lambda=1.2856504859057132e-02 >>> > > Line search: Cubically determined step, current gnorm >>> 1.797121460957e+02 lambda=1.4396611381500967e-03 >>> > > 45 SNES Function norm 1.797121460957e+02 >>> > > 0 KSP Residual norm 6.613432967985e+00 >>> > > 1 KSP Residual norm 1.357752977076e-13 >>> > > Line search: gnorm after quadratic fit 2.721288927858e+02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.939638282615e+02 lambda=5.0000000000000003e-02 >>> > > Line search: Cubically determined step, current gnorm >>> 1.787985482018e+02 lambda=1.2647907914070569e-02 >>> > > 46 SNES Function norm 1.787985482018e+02 >>> > > 0 KSP Residual norm 1.225736349281e+01 >>> > > 1 KSP Residual norm 3.819378790812e-13 >>> > > Line search: gnorm after quadratic fit 4.548006065036e+02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.304803559060e+02 lambda=5.0000000000000003e-02 >>> > > Line search: Cubically determined step, current gnorm >>> 1.787344729174e+02 lambda=8.9002284237256531e-03 >>> > > 47 SNES Function norm 1.787344729174e+02 >>> > > 0 KSP Residual norm 6.302465402340e+00 >>> > > 1 KSP Residual norm 6.980931947122e-14 >>> > > Line search: gnorm after quadratic fit 2.879477700004e+02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.980806946742e+02 lambda=5.0000000000000003e-02 >>> > > Line search: Cubically determined step, current gnorm >>> 1.780128006935e+02 lambda=1.0223293444602008e-02 >>> > > 48 SNES Function norm 1.780128006935e+02 >>> > > 0 KSP Residual norm 4.323829277968e+00 >>> > > 1 KSP Residual norm 5.223881369308e-13 >>> > > Line search: gnorm after quadratic fit 1.957928151218e+02 >>> > > Line search: Cubically determined step, current gnorm >>> 1.768899805640e+02 lambda=5.0000000000000003e-02 >>> > > 49 SNES Function norm 1.768899805640e+02 >>> > > 0 KSP Residual norm 2.249256107033e+00 >>> > > 1 KSP Residual norm 3.624400957270e-14 >>> > > Line search: gnorm after quadratic fit 1.704782114773e+02 >>> > > Line search: Quadratically determined step, >>> lambda=1.0000000000000001e-01 >>> > > 50 SNES Function norm 1.704782114773e+02 >>> > > 0 SNES Function norm 3.513783397332e+03 >>> > > 0 KSP Residual norm 1.650214950648e+01 >>> > > 1 KSP Residual norm 3.574269752690e-13 >>> > > Line search: gnorm after quadratic fit 3.155830404050e+03 >>> > > Line search: Quadratically determined step, >>> lambda=1.0000000000000001e-01 >>> > > 1 SNES Function norm 3.155830404050e+03 >>> > > 0 KSP Residual norm 1.443734018042e+01 >>> > > 1 KSP Residual norm 3.685565191058e-13 >>> > > Line search: Using full step: fnorm 3.155830404050e+03 gnorm >>> 8.581212204155e+02 >>> > > 2 SNES Function norm 8.581212204155e+02 >>> > > 0 KSP Residual norm 2.492601775565e+00 >>> > > 1 KSP Residual norm 9.698440210389e-14 >>> > > Line search: Using full step: fnorm 8.581212204155e+02 gnorm >>> 7.018609898542e+02 >>> > > 3 SNES Function norm 7.018609898542e+02 >>> > > 0 KSP Residual norm 1.740320986421e+00 >>> > > 1 KSP Residual norm 2.868780682435e-14 >>> > > Line search: Using full step: fnorm 7.018609898542e+02 gnorm >>> 2.135824235887e+02 >>> > > 4 SNES Function norm 2.135824235887e+02 >>> > > 0 KSP Residual norm 1.647413497077e+00 >>> > > 1 KSP Residual norm 2.731226225666e-14 >>> > > Line search: gnorm after quadratic fit 1.936469032649e+02 >>> > > Line search: Quadratically determined step, >>> lambda=1.0000000000000001e-01 >>> > > 5 SNES Function norm 1.936469032649e+02 >>> > > 0 KSP Residual norm 1.406615972124e+00 >>> > > 1 KSP Residual norm 3.167179626699e-14 >>> > > Line search: gnorm after quadratic fit 1.755362571467e+02 >>> > > Line search: Quadratically determined step, >>> lambda=1.0000000000000001e-01 >>> > > 6 SNES Function norm 1.755362571467e+02 >>> > > 0 KSP Residual norm 1.480681706594e+00 >>> > > 1 KSP Residual norm 2.935210968935e-14 >>> > > Line search: gnorm after quadratic fit 1.597659506616e+02 >>> > > Line search: Quadratically determined step, >>> lambda=1.0000000000000001e-01 >>> > > 7 SNES Function norm 1.597659506616e+02 >>> > > 0 KSP Residual norm 4.013154698097e+00 >>> > > 1 KSP Residual norm 1.021628704832e-13 >>> > > Line search: gnorm after quadratic fit 1.728408060966e+02 >>> > > Line search: Cubically determined step, current gnorm >>> 1.570815760721e+02 lambda=5.0000000000000003e-02 >>> > > 8 SNES Function norm 1.570815760721e+02 >>> > > 0 KSP Residual norm 1.510335662636e+00 >>> > > 1 KSP Residual norm 2.728243244724e-14 >>> > > Line search: gnorm after quadratic fit 1.450162880692e+02 >>> > > Line search: Quadratically determined step, >>> lambda=1.0000000000000001e-01 >>> > > 9 SNES Function norm 1.450162880692e+02 >>> > > 0 KSP Residual norm 1.923349271077e+01 >>> > > 1 KSP Residual norm 1.640711956406e-11 >>> > > Line search: gnorm after quadratic fit 1.016537223115e+03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.584263092048e+02 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.490729346583e+02 lambda=9.3725990358703350e-03 >>> > > Line search: Cubically determined step, current gnorm >>> 1.449349273006e+02 lambda=1.5464889706033082e-03 >>> > > 10 SNES Function norm 1.449349273006e+02 >>> > > 0 KSP Residual norm 1.154999084194e+01 >>> > > 1 KSP Residual norm 1.292167633338e-11 >>> > > Line search: gnorm after quadratic fit 6.060386918705e+02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.236630526035e+02 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.491201927819e+02 lambda=1.6816056300124185e-02 >>> > > Line search: Cubically determined step, current gnorm >>> 1.447023047013e+02 lambda=4.1484374564153808e-03 >>> > > 11 SNES Function norm 1.447023047013e+02 >>> > > 0 KSP Residual norm 7.278906180502e+00 >>> > > 1 KSP Residual norm 2.815632651924e-12 >>> > > Line search: gnorm after quadratic fit 2.512278711773e+02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.624350957814e+02 lambda=5.0000000000000003e-02 >>> > > Line search: Cubically determined step, current gnorm >>> 1.441656049510e+02 lambda=1.0879389002513012e-02 >>> > > 12 SNES Function norm 1.441656049510e+02 >>> > > 0 KSP Residual norm 4.449836480267e+00 >>> > > 1 KSP Residual norm 3.152365624813e-13 >>> > > Line search: gnorm after quadratic fit 1.749680739878e+02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.458763435996e+02 lambda=5.0000000000000003e-02 >>> > > Line search: Cubically determined step, current gnorm >>> 1.425715025152e+02 lambda=2.2766809271842225e-02 >>> > > 13 SNES Function norm 1.425715025152e+02 >>> > > 0 KSP Residual norm 4.218495037726e+00 >>> > > 1 KSP Residual norm 1.398472536142e-12 >>> > > Line search: gnorm after quadratic fit 1.645159536467e+02 >>> > > Line search: Cubically determined step, current gnorm >>> 1.421991559212e+02 lambda=4.1883769431247941e-02 >>> > > 14 SNES Function norm 1.421991559212e+02 >>> > > 0 KSP Residual norm 1.968853538608e+00 >>> > > 1 KSP Residual norm 7.594023450519e-12 >>> > > Line search: gnorm after quadratic fit 1.350960142124e+02 >>> > > Line search: Quadratically determined step, >>> lambda=1.0000000000000001e-01 >>> > > 15 SNES Function norm 1.350960142124e+02 >>> > > 0 KSP Residual norm 3.444721686085e+00 >>> > > 1 KSP Residual norm 5.312609674019e-14 >>> > > Line search: gnorm after quadratic fit 1.472880565107e+02 >>> > > Line search: Cubically determined step, current gnorm >>> 1.336714620145e+02 lambda=4.1341550820829437e-02 >>> > > 16 SNES Function norm 1.336714620145e+02 >>> > > 0 KSP Residual norm 3.276288899397e+00 >>> > > 1 KSP Residual norm 8.394674946715e-14 >>> > > Line search: gnorm after quadratic fit 1.459274497150e+02 >>> > > Line search: Cubically determined step, current gnorm >>> 1.327618539486e+02 lambda=5.0000000000000003e-02 >>> > > 17 SNES Function norm 1.327618539486e+02 >>> > > 0 KSP Residual norm 2.630052244303e+00 >>> > > 1 KSP Residual norm 4.351283410507e-14 >>> > > Line search: gnorm after quadratic fit 1.350378060116e+02 >>> > > Line search: Cubically determined step, current gnorm >>> 1.299403903934e+02 lambda=4.9913529436269283e-02 >>> > > 18 SNES Function norm 1.299403903934e+02 >>> > > 0 KSP Residual norm 6.124953430138e+00 >>> > > 1 KSP Residual norm 2.295381352938e-13 >>> > > Line search: gnorm after quadratic fit 2.275621676963e+02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.469611730657e+02 lambda=5.0000000000000003e-02 >>> > > Line search: Cubically determined step, current gnorm >>> 1.294890694898e+02 lambda=1.0071939100661648e-02 >>> > > 19 SNES Function norm 1.294890694898e+02 >>> > > 0 KSP Residual norm 1.036733907011e+01 >>> > > 1 KSP Residual norm 1.800941381283e-13 >>> > > Line search: gnorm after quadratic fit 3.844879463595e+02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.875071148504e+02 lambda=5.0000000000000003e-02 >>> > > Line search: Cubically determined step, current gnorm >>> 1.294494430642e+02 lambda=5.0000000000000010e-03 >>> > > 20 SNES Function norm 1.294494430642e+02 >>> > > 0 KSP Residual norm 8.224001595443e+00 >>> > > 1 KSP Residual norm 3.337810156182e-13 >>> > > Line search: gnorm after quadratic fit 3.332325263497e+02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.682441841234e+02 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.294720538860e+02 lambda=8.5401597581228530e-03 >>> > > Line search: Cubically determined step, current gnorm >>> 1.291762382985e+02 lambda=4.2555418164960989e-03 >>> > > 21 SNES Function norm 1.291762382985e+02 >>> > > 0 KSP Residual norm 3.920749219860e+01 >>> > > 1 KSP Residual norm 1.610902886435e-12 >>> > > Line search: gnorm after quadratic fit 3.472422440640e+03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.023065712859e+03 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.228184088700e+02 lambda=1.6004598823093592e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.298607525058e+02 lambda=1.6004598823093593e-03 >>> > > Line search: Cubically determined step, current gnorm >>> 1.291643460998e+02 lambda=1.9319076533745672e-04 >>> > > 22 SNES Function norm 1.291643460998e+02 >>> > > 0 KSP Residual norm 1.520092314848e+02 >>> > > 1 KSP Residual norm 7.089159192434e-11 >>> > > Line search: gnorm after quadratic fit 2.752539686422e+05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 4.237188995536e+04 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 7.484370498858e+03 lambda=2.5000000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.571039994484e+03 lambda=1.2500000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 4.280898858362e+02 lambda=6.2500000000000003e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.708927009106e+02 lambda=2.6114913411793973e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.294919567784e+02 lambda=2.6114913411793975e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.291645609810e+02 lambda=2.6114913411793977e-05 >>> > > Line search: Cubically determined step, current gnorm >>> 1.291635530596e+02 lambda=1.2278773895355162e-05 >>> > > 23 SNES Function norm 1.291635530596e+02 >>> > > 0 KSP Residual norm 7.569206058965e+02 >>> > > 1 KSP Residual norm 3.454693729751e-11 >>> > > Line search: gnorm after quadratic fit 2.570888738395e+07 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.064965025187e+06 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.498514098182e+05 lambda=2.5000000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.807487005202e+04 lambda=1.2500000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 5.233167830543e+03 lambda=6.2500000000000003e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.396736912757e+03 lambda=3.1250000000000002e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.547572543330e+02 lambda=1.2623406091699435e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.335889024473e+02 lambda=1.8542137907683829e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.292059042479e+02 lambda=1.8542137907683831e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.291637618568e+02 lambda=1.8542137907683832e-06 >>> > > Line search: Cubically determined step, current gnorm >>> 1.291635210734e+02 lambda=4.9524172913414387e-07 >>> > > 24 SNES Function norm 1.291635210734e+02 >>> > > 0 KSP Residual norm 3.761913422861e+03 >>> > > 1 KSP Residual norm 6.181718776929e-10 >>> > > Line search: gnorm after quadratic fit 3.342370445037e+09 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 4.218326646111e+08 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 5.375128803204e+07 lambda=2.5000000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 6.980626157021e+06 lambda=1.2500000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 9.407418671219e+05 lambda=6.2500000000000003e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.357321025399e+05 lambda=3.1250000000000002e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.188948059047e+04 lambda=1.5625000000000001e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 4.105117929713e+03 lambda=7.8125000000000004e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 9.331054736818e+02 lambda=3.9062500000000002e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.942479792843e+02 lambda=1.9412500272460620e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.436944624694e+02 lambda=6.4483223307578726e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.292972287211e+02 lambda=6.4483223307578726e-06 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.291647778160e+02 lambda=6.4483223307578730e-07 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.291635261433e+02 lambda=6.4483223307578730e-08 >>> > > Line search: Cubically determined step, current gnorm >>> 1.291635197798e+02 lambda=2.0042115918485846e-08 >>> > > 25 SNES Function norm 1.291635197798e+02 >>> > > 0 KSP Residual norm 1.874745766083e+04 >>> > > 1 KSP Residual norm 1.476978150334e-09 >>> > > Line search: gnorm after quadratic fit 4.089262111368e+11 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 5.101717203770e+10 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 6.352565940292e+09 lambda=2.5000000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 7.879613196620e+08 lambda=1.2500000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 9.698613558125e+07 lambda=6.2500000000000003e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.175566265039e+07 lambda=3.1250000000000002e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.382919964952e+06 lambda=1.5625000000000001e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.545431975334e+05 lambda=7.8125000000000004e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.713561369103e+04 lambda=3.9062500000000002e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.031789308419e+03 lambda=1.9531250000000001e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 9.205847020738e+02 lambda=9.7656250000000005e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.957203153158e+02 lambda=2.8132879163728503e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.297923302791e+02 lambda=2.8132879163728504e-06 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.291698100579e+02 lambda=2.8132879163728504e-07 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.291635794525e+02 lambda=2.8132879163728506e-08 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.291635200489e+02 lambda=2.8132879163728508e-09 >>> > > Line search: Cubically determined step, current gnorm >>> 1.291635197275e+02 lambda=8.0832061492461345e-10 >>> > > 26 SNES Function norm 1.291635197275e+02 >>> > > 0 KSP Residual norm 9.248381077528e+04 >>> > > 1 KSP Residual norm 7.262307068447e-09 >>> > > Line search: gnorm after quadratic fit 4.920647210624e+13 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 6.153216818065e+12 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 7.697543960375e+11 lambda=2.5000000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 9.637004379805e+10 lambda=1.2500000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.208402653149e+10 lambda=6.2500000000000003e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.519988135798e+09 lambda=3.1250000000000002e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.923903214787e+08 lambda=1.5625000000000001e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.465663001976e+07 lambda=7.8125000000000004e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.238603967195e+06 lambda=3.9062500000000002e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 4.459179143177e+05 lambda=1.9531250000000001e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 6.676301042792e+04 lambda=9.7656250000000005e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.135808875752e+04 lambda=4.8828125000000003e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.275714918657e+03 lambda=2.4414062500000001e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 5.719037747616e+02 lambda=1.2207031250000001e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.039826156716e+02 lambda=5.5609199181402721e-06 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.308092967809e+02 lambda=9.1057337296683134e-07 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.291796742824e+02 lambda=9.1057337296683134e-08 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.291636800174e+02 lambda=9.1057337296683134e-09 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.291635212255e+02 lambda=9.1057337296683134e-10 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.291635197320e+02 lambda=9.1057337296683139e-11 >>> > > Line search: Cubically determined step, current gnorm >>> 1.291635197254e+02 lambda=3.2898162617097329e-11 >>> > > 27 SNES Function norm 1.291635197254e+02 >>> > > 0 KSP Residual norm 4.818745996826e+05 >>> > > 1 KSP Residual norm 3.300979345194e-08 >>> > > Line search: gnorm after quadratic fit 6.957046028867e+15 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 8.695654311477e+14 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.086793500688e+14 lambda=2.5000000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.358083744813e+13 lambda=1.2500000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.696584801696e+12 lambda=6.2500000000000003e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.118183549773e+11 lambda=3.1250000000000002e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.641372080976e+10 lambda=1.5625000000000001e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.285878535769e+09 lambda=7.8125000000000004e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 4.068045470276e+08 lambda=3.9062500000000002e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 4.988290932539e+07 lambda=1.9531250000000001e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 6.001404304764e+06 lambda=9.7656250000000005e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 6.962234585736e+05 lambda=4.8828125000000003e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 7.648190078115e+04 lambda=2.4414062500000001e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 9.098288624714e+03 lambda=1.2207031250000001e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.025132922751e+03 lambda=6.1035156250000003e-06 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 6.536770142392e+02 lambda=3.0517578125000002e-06 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.529553964021e+02 lambda=6.6615844706846272e-07 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.293970371303e+02 lambda=6.6615844706846277e-08 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.291658631829e+02 lambda=6.6615844706846284e-09 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.291635430890e+02 lambda=6.6615844706846284e-10 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.291635199508e+02 lambda=6.6615844706846284e-11 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.291635197268e+02 lambda=6.6615844706846284e-12 >>> > > Line search: Cubically determined step, current gnorm >>> 1.291635197253e+02 lambda=1.2496728806533799e-12 >>> > > 28 SNES Function norm 1.291635197253e+02 >>> > > 0 KSP Residual norm 2.124622394867e+06 >>> > > 1 KSP Residual norm 2.766225333896e-07 >>> > > Line search: gnorm after quadratic fit 5.963587884154e+17 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 7.454611858824e+16 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 9.318582340500e+15 lambda=2.5000000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.164902175749e+15 lambda=1.2500000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.456326197371e+14 lambda=6.2500000000000003e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.820904039469e+13 lambda=3.1250000000000002e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.277371273495e+12 lambda=1.5625000000000001e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.849819609184e+11 lambda=7.8125000000000004e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.570050545145e+10 lambda=3.9062500000000002e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 4.482064028328e+09 lambda=1.9531250000000001e-04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 5.651631635063e+08 lambda=9.7656250000000005e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 7.188623828904e+07 lambda=4.8828125000000003e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 9.302868645305e+06 lambda=2.4414062500000001e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.245214424313e+06 lambda=1.2207031250000001e-05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.775004618570e+05 lambda=6.1035156250000003e-06 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.810228834086e+04 lambda=3.0517578125000002e-06 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 5.148910945566e+03 lambda=1.5258789062500001e-06 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.133679879416e+03 lambda=7.6293945312500004e-07 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.382468615011e+02 lambda=3.8146972656250002e-07 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.519773483633e+02 lambda=1.4103864371136453e-07 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.293690599792e+02 lambda=1.4103864371136454e-08 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.291655645282e+02 lambda=1.4103864371136455e-09 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.291635401518e+02 lambda=1.4103864371136456e-10 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.291635199283e+02 lambda=1.4103864371136456e-11 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.291635197272e+02 lambda=1.4103864371136456e-12 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.291635197253e+02 lambda=1.4103864371136457e-13 >>> > > Line search: unable to find good step length! After 25 tries >>> > > Line search: fnorm=1.2916351972528861e+02, >>> gnorm=1.2916351972529532e+02, ynorm=2.1246218291095798e+06, >>> minlambda=9.9999999999999998e-13, lambda=1.4103864371136457e-13, >>> initial slope=-1.6683210999382733e+04 >>> > > 0 SNES Function norm 7.158176401507e+03 >>> > > 0 KSP Residual norm 7.545626598553e+02 >>> > > 1 KSP Residual norm 2.192822940623e-11 >>> > > Line search: gnorm after quadratic fit 6.003975664723e+07 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 7.501930637484e+06 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 9.380142516806e+05 lambda=2.5000000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.179837352860e+05 lambda=1.2500000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.656902039419e+04 lambda=6.2500000000000003e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 7.340091686120e+03 lambda=3.1250000000000002e-03 >>> > > Line search: Cubically determined step, current gnorm >>> 7.127478647243e+03 lambda=1.5625000000000001e-03 >>> > > 1 SNES Function norm 7.127478647243e+03 >>> > > 0 KSP Residual norm 3.139792512249e+01 >>> > > 1 KSP Residual norm 5.765552480238e-13 >>> > > Line search: gnorm after quadratic fit 7.131728282938e+03 >>> > > Line search: Cubically determined step, current gnorm >>> 6.730387269330e+03 lambda=5.0000000000000003e-02 >>> > > 2 SNES Function norm 6.730387269330e+03 >>> > > 0 KSP Residual norm 2.247436817553e+01 >>> > > 1 KSP Residual norm 4.129717651221e-13 >>> > > Line search: gnorm after quadratic fit 6.018304311910e+03 >>> > > Line search: Quadratically determined step, >>> lambda=1.0000000000000001e-01 >>> > > 3 SNES Function norm 6.018304311910e+03 >>> > > 0 KSP Residual norm 1.605973421081e+01 >>> > > 1 KSP Residual norm 3.614891198134e-13 >>> > > Line search: gnorm after quadratic fit 5.394599276028e+03 >>> > > Line search: Quadratically determined step, >>> lambda=1.0000000000000001e-01 >>> > > 4 SNES Function norm 5.394599276028e+03 >>> > > 0 KSP Residual norm 1.491002227850e+01 >>> > > 1 KSP Residual norm 5.905756964447e-13 >>> > > Line search: gnorm after quadratic fit 4.845108544722e+03 >>> > > Line search: Quadratically determined step, >>> lambda=1.0000000000000001e-01 >>> > > 5 SNES Function norm 4.845108544722e+03 >>> > > 0 KSP Residual norm 1.562997766581e+02 >>> > > 1 KSP Residual norm 5.722461855805e-12 >>> > > Line search: gnorm after quadratic fit 1.663505509947e+05 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.368547472010e+04 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 6.067825049920e+03 lambda=2.5000000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 4.852173464442e+03 lambda=1.2500000000000001e-02 >>> > > Line search: Cubically determined step, current gnorm >>> 4.819549937425e+03 lambda=6.2500000000000003e-03 >>> > > 6 SNES Function norm 4.819549937425e+03 >>> > > 0 KSP Residual norm 1.652787385042e+01 >>> > > 1 KSP Residual norm 7.774483442550e-13 >>> > > Line search: gnorm after quadratic fit 2.868840270198e+03 >>> > > Line search: Quadratically determined step, >>> lambda=3.9586658383856743e-01 >>> > > 7 SNES Function norm 2.868840270198e+03 >>> > > 0 KSP Residual norm 1.220061851091e+01 >>> > > 1 KSP Residual norm 4.785407437718e-13 >>> > > Line search: gnorm after quadratic fit 2.616720732407e+03 >>> > > Line search: Quadratically determined step, >>> lambda=1.0000000000000001e-01 >>> > > 8 SNES Function norm 2.616720732407e+03 >>> > > 0 KSP Residual norm 2.884722153958e+01 >>> > > 1 KSP Residual norm 5.474553921306e-13 >>> > > Line search: gnorm after quadratic fit 3.025386805317e+03 >>> > > Line search: Cubically determined step, current gnorm >>> 2.572110173067e+03 lambda=5.0000000000000003e-02 >>> > > 9 SNES Function norm 2.572110173067e+03 >>> > > 0 KSP Residual norm 5.239447686736e+01 >>> > > 1 KSP Residual norm 1.006906008399e-12 >>> > > Line search: gnorm after quadratic fit 5.237562098046e+03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.722529781980e+03 lambda=5.0000000000000003e-02 >>> > > Line search: Cubically determined step, current gnorm >>> 2.553072891461e+03 lambda=2.5000000000000001e-02 >>> > > 10 SNES Function norm 2.553072891461e+03 >>> > > 0 KSP Residual norm 6.511316788880e+00 >>> > > 1 KSP Residual norm 1.340296659008e-13 >>> > > Line search: gnorm after quadratic fit 2.299704119080e+03 >>> > > Line search: Quadratically determined step, >>> lambda=1.0000000000000001e-01 >>> > > 11 SNES Function norm 2.299704119080e+03 >>> > > 0 KSP Residual norm 5.268131426587e+00 >>> > > 1 KSP Residual norm 1.017563310127e-13 >>> > > Line search: Using full step: fnorm 2.299704119080e+03 gnorm >>> 7.642690039388e+02 >>> > > 12 SNES Function norm 7.642690039388e+02 >>> > > 0 KSP Residual norm 1.467735721574e+01 >>> > > 1 KSP Residual norm 1.090242963543e-12 >>> > > Line search: gnorm after quadratic fit 1.042766084830e+03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 7.924803860137e+02 lambda=5.0000000000000003e-02 >>> > > Line search: Cubically determined step, current gnorm >>> 7.581126971182e+02 lambda=1.8508848315139208e-02 >>> > > 13 SNES Function norm 7.581126971182e+02 >>> > > 0 KSP Residual norm 2.222609581896e+00 >>> > > 1 KSP Residual norm 5.661437314341e-14 >>> > > Line search: gnorm after quadratic fit 6.235337602260e+02 >>> > > Line search: Quadratically determined step, >>> lambda=2.1172883827013136e-01 >>> > > 14 SNES Function norm 6.235337602260e+02 >>> > > 0 KSP Residual norm 3.080209609798e+00 >>> > > 1 KSP Residual norm 6.073476899313e-14 >>> > > Line search: gnorm after quadratic fit 5.704745248520e+02 >>> > > Line search: Quadratically determined step, >>> lambda=1.0142301129466913e-01 >>> > > 15 SNES Function norm 5.704745248520e+02 >>> > > 0 KSP Residual norm 5.628316803979e+00 >>> > > 1 KSP Residual norm 9.930477041779e-14 >>> > > Line search: gnorm after quadratic fit 5.401354794776e+02 >>> > > Line search: Quadratically determined step, >>> lambda=1.0000000000000001e-01 >>> > > 16 SNES Function norm 5.401354794776e+02 >>> > > 0 KSP Residual norm 2.052541406719e+01 >>> > > 1 KSP Residual norm 4.328836834239e-13 >>> > > Line search: gnorm after quadratic fit 1.709850100987e+03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 7.717966555703e+02 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 5.414032576976e+02 lambda=8.7805694170804971e-03 >>> > > Line search: Cubically determined step, current gnorm >>> 5.391967144330e+02 lambda=3.6341472475199424e-03 >>> > > 17 SNES Function norm 5.391967144330e+02 >>> > > 0 KSP Residual norm 2.246993769488e+00 >>> > > 1 KSP Residual norm 5.078373642913e-14 >>> > > Line search: gnorm after quadratic fit 4.939618639951e+02 >>> > > Line search: Quadratically determined step, >>> lambda=1.0000000000000001e-01 >>> > > 18 SNES Function norm 4.939618639951e+02 >>> > > 0 KSP Residual norm 2.155867648564e+00 >>> > > 1 KSP Residual norm 4.438622106380e-14 >>> > > Line search: gnorm after quadratic fit 4.334377322188e+02 >>> > > Line search: Quadratically determined step, >>> lambda=1.5092486954829210e-01 >>> > > 19 SNES Function norm 4.334377322188e+02 >>> > > 0 KSP Residual norm 8.318284791610e+00 >>> > > 1 KSP Residual norm 6.910116607023e-13 >>> > > Line search: gnorm after quadratic fit 6.148799641401e+02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 4.502386288041e+02 lambda=5.0000000000000003e-02 >>> > > Line search: Cubically determined step, current gnorm >>> 4.297879862602e+02 lambda=1.9565738732695813e-02 >>> > > 20 SNES Function norm 4.297879862602e+02 >>> > > 0 KSP Residual norm 7.593855254976e+01 >>> > > 1 KSP Residual norm 1.300639045149e-12 >>> > > Line search: gnorm after quadratic fit 7.318016560287e+04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 7.832525429452e+03 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.543595712952e+03 lambda=2.5000000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 6.752901058720e+02 lambda=1.2500000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 4.309726315570e+02 lambda=1.2500000000000002e-03 >>> > > Line search: Cubically determined step, current gnorm >>> 4.297464967378e+02 lambda=2.0986409143217158e-04 >>> > > 21 SNES Function norm 4.297464967378e+02 >>> > > 0 KSP Residual norm 8.492609701850e+00 >>> > > 1 KSP Residual norm 2.830329105288e-13 >>> > > Line search: gnorm after quadratic fit 6.575200413213e+02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 4.532760802544e+02 lambda=5.0000000000000003e-02 >>> > > Line search: Cubically determined step, current gnorm >>> 4.268212296998e+02 lambda=1.8460064973695799e-02 >>> > > 22 SNES Function norm 4.268212296998e+02 >>> > > 0 KSP Residual norm 2.527155905469e+00 >>> > > 1 KSP Residual norm 2.235724978394e-13 >>> > > Line search: gnorm after quadratic fit 3.958132075117e+02 >>> > > Line search: Quadratically determined step, >>> lambda=1.0000000000000001e-01 >>> > > 23 SNES Function norm 3.958132075117e+02 >>> > > 0 KSP Residual norm 3.425644398425e+00 >>> > > 1 KSP Residual norm 7.166017790799e-14 >>> > > Line search: gnorm after quadratic fit 3.803199338641e+02 >>> > > Line search: Quadratically determined step, >>> lambda=1.0000000000000001e-01 >>> > > 24 SNES Function norm 3.803199338641e+02 >>> > > 0 KSP Residual norm 3.581435186688e+00 >>> > > 1 KSP Residual norm 1.730091027109e-13 >>> > > Line search: gnorm after quadratic fit 3.678433353709e+02 >>> > > Line search: Quadratically determined step, >>> lambda=1.0000000000000001e-01 >>> > > 25 SNES Function norm 3.678433353709e+02 >>> > > 0 KSP Residual norm 2.817439291614e+00 >>> > > 1 KSP Residual norm 8.592333136485e-13 >>> > > Line search: gnorm after quadratic fit 3.472671313564e+02 >>> > > Line search: Quadratically determined step, >>> lambda=1.0000000000000001e-01 >>> > > 26 SNES Function norm 3.472671313564e+02 >>> > > 0 KSP Residual norm 1.830066839089e+00 >>> > > 1 KSP Residual norm 3.248934231575e-14 >>> > > Line search: gnorm after quadratic fit 3.195079998571e+02 >>> > > Line search: Quadratically determined step, >>> lambda=1.0000000000000001e-01 >>> > > 27 SNES Function norm 3.195079998571e+02 >>> > > 0 KSP Residual norm 3.775823654589e+00 >>> > > 1 KSP Residual norm 1.316233059492e-13 >>> > > Line search: gnorm after quadratic fit 3.252874639934e+02 >>> > > Line search: Cubically determined step, current gnorm >>> 3.125168318399e+02 lambda=5.0000000000000003e-02 >>> > > 28 SNES Function norm 3.125168318399e+02 >>> > > 0 KSP Residual norm 3.892613775622e+00 >>> > > 1 KSP Residual norm 7.093200713216e-11 >>> > > Line search: gnorm after quadratic fit 3.137590389484e+02 >>> > > Line search: Cubically determined step, current gnorm >>> 3.045559021319e+02 lambda=5.0000000000000003e-02 >>> > > 29 SNES Function norm 3.045559021319e+02 >>> > > 0 KSP Residual norm 2.364531179390e+00 >>> > > 1 KSP Residual norm 1.615423543115e-12 >>> > > Line search: gnorm after quadratic fit 2.864449141431e+02 >>> > > Line search: Quadratically determined step, >>> lambda=1.0000000000000001e-01 >>> > > 30 SNES Function norm 2.864449141431e+02 >>> > > 0 KSP Residual norm 5.187063704081e+00 >>> > > 1 KSP Residual norm 4.254799504045e-13 >>> > > Line search: gnorm after quadratic fit 3.171238299438e+02 >>> > > Line search: Cubically determined step, current gnorm >>> 2.859321807369e+02 lambda=4.9550691080557742e-02 >>> > > 31 SNES Function norm 2.859321807369e+02 >>> > > 0 KSP Residual norm 2.400449127985e+01 >>> > > 1 KSP Residual norm 5.221032480453e-13 >>> > > Line search: gnorm after quadratic fit 1.812538817802e+03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 6.647888939229e+02 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.905120335847e+02 lambda=7.3371687404129469e-03 >>> > > Line search: Cubically determined step, current gnorm >>> 2.857698450683e+02 lambda=1.3231746793531958e-03 >>> > > 32 SNES Function norm 2.857698450683e+02 >>> > > 0 KSP Residual norm 7.438521293559e+00 >>> > > 1 KSP Residual norm 1.293652874831e-12 >>> > > Line search: gnorm after quadratic fit 3.600694148787e+02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.932936811991e+02 lambda=5.0000000000000003e-02 >>> > > Line search: Cubically determined step, current gnorm >>> 2.832774969882e+02 lambda=1.8636088141277370e-02 >>> > > 33 SNES Function norm 2.832774969882e+02 >>> > > 0 KSP Residual norm 2.676138557891e+00 >>> > > 1 KSP Residual norm 5.204105674042e-12 >>> > > Line search: gnorm after quadratic fit 2.698470565576e+02 >>> > > Line search: Quadratically determined step, >>> lambda=1.0000000000000001e-01 >>> > > 34 SNES Function norm 2.698470565576e+02 >>> > > 0 KSP Residual norm 1.009562156863e+01 >>> > > 1 KSP Residual norm 3.544140587695e-13 >>> > > Line search: gnorm after quadratic fit 5.672695948559e+02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.197216154647e+02 lambda=5.0000000000000003e-02 >>> > > Line search: Cubically determined step, current gnorm >>> 2.694068135292e+02 lambda=1.0762403784106927e-02 >>> > > 35 SNES Function norm 2.694068135292e+02 >>> > > 0 KSP Residual norm 3.927549314525e+00 >>> > > 1 KSP Residual norm 2.619134786598e-13 >>> > > Line search: gnorm after quadratic fit 2.646675787349e+02 >>> > > Line search: Quadratically determined step, >>> lambda=1.0000000000000001e-01 >>> > > 36 SNES Function norm 2.646675787349e+02 >>> > > 0 KSP Residual norm 3.630219417922e+01 >>> > > 1 KSP Residual norm 1.546302717349e-12 >>> > > Line search: gnorm after quadratic fit 1.827432666108e+04 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.342968941151e+03 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 8.008633273369e+02 lambda=2.5000000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.490753494196e+02 lambda=1.2345129233072847e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.682474011960e+02 lambda=3.3291959087019770e-03 >>> > > Line search: Cubically determined step, current gnorm >>> 2.646227701989e+02 lambda=4.0529212866107715e-04 >>> > > 37 SNES Function norm 2.646227701989e+02 >>> > > 0 KSP Residual norm 8.122774697994e+00 >>> > > 1 KSP Residual norm 1.316362046092e-13 >>> > > Line search: gnorm after quadratic fit 4.731092571363e+02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.030088374328e+02 lambda=5.0000000000000003e-02 >>> > > Line search: Cubically determined step, current gnorm >>> 2.637462652877e+02 lambda=9.1057248517509397e-03 >>> > > 38 SNES Function norm 2.637462652877e+02 >>> > > 0 KSP Residual norm 2.601520363063e+00 >>> > > 1 KSP Residual norm 1.060764270007e-12 >>> > > Line search: gnorm after quadratic fit 2.536856446094e+02 >>> > > Line search: Quadratically determined step, >>> lambda=1.0000000000000001e-01 >>> > > 39 SNES Function norm 2.536856446094e+02 >>> > > 0 KSP Residual norm 5.447955134327e+01 >>> > > 1 KSP Residual norm 2.556989975730e-12 >>> > > Line search: gnorm after quadratic fit 9.199250935618e+03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.998238940105e+03 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 6.227083769291e+02 lambda=2.5000000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.852215674478e+02 lambda=8.5024965111563117e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.537821339347e+02 lambda=8.5024965111563122e-04 >>> > > Line search: Cubically determined step, current gnorm >>> 2.536484146652e+02 lambda=2.9594242443314720e-04 >>> > > 40 SNES Function norm 2.536484146652e+02 >>> > > 0 KSP Residual norm 3.357359266965e+01 >>> > > 1 KSP Residual norm 8.485166742752e-11 >>> > > Line search: gnorm after quadratic fit 3.327150899857e+03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 8.660943990394e+02 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.428891921377e+02 lambda=2.2262238648584176e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.550059920785e+02 lambda=3.9120439672600755e-03 >>> > > Line search: Cubically determined step, current gnorm >>> 2.535425543202e+02 lambda=8.8078244093807846e-04 >>> > > 41 SNES Function norm 2.535425543202e+02 >>> > > 0 KSP Residual norm 1.982789391732e+01 >>> > > 1 KSP Residual norm 1.156473750758e-11 >>> > > Line search: gnorm after quadratic fit 9.648483369708e+02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 4.023504841042e+02 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.554919970151e+02 lambda=8.7092873850291869e-03 >>> > > Line search: Cubically determined step, current gnorm >>> 2.532490636747e+02 lambda=2.4564558988847251e-03 >>> > > 42 SNES Function norm 2.532490636747e+02 >>> > > 0 KSP Residual norm 1.762994613361e+01 >>> > > 1 KSP Residual norm 4.550684860593e-12 >>> > > Line search: gnorm after quadratic fit 6.772107527838e+02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.370541870778e+02 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.532869639177e+02 lambda=7.7662700854918328e-03 >>> > > Line search: Cubically determined step, current gnorm >>> 2.527651129995e+02 lambda=3.8686733161537824e-03 >>> > > 43 SNES Function norm 2.527651129995e+02 >>> > > 0 KSP Residual norm 1.559278923951e+01 >>> > > 1 KSP Residual norm 1.060470887103e-11 >>> > > Line search: gnorm after quadratic fit 7.344361373020e+02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.498001534426e+02 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.530518382567e+02 lambda=7.6730113050967469e-03 >>> > > Line search: Cubically determined step, current gnorm >>> 2.523423548732e+02 lambda=3.4156098513217236e-03 >>> > > 44 SNES Function norm 2.523423548732e+02 >>> > > 0 KSP Residual norm 1.190500639095e+01 >>> > > 1 KSP Residual norm 6.311739265577e-12 >>> > > Line search: gnorm after quadratic fit 4.875196633557e+02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.933215922947e+02 lambda=5.0000000000000003e-02 >>> > > Line search: Cubically determined step, current gnorm >>> 2.516782376717e+02 lambda=9.8878729665301743e-03 >>> > > 45 SNES Function norm 2.516782376717e+02 >>> > > 0 KSP Residual norm 1.003632001309e+01 >>> > > 1 KSP Residual norm 7.039473047666e-13 >>> > > Line search: gnorm after quadratic fit 3.417133560813e+02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.636443273929e+02 lambda=5.0000000000000003e-02 >>> > > Line search: Cubically determined step, current gnorm >>> 2.499729768042e+02 lambda=1.5332495922160540e-02 >>> > > 46 SNES Function norm 2.499729768042e+02 >>> > > 0 KSP Residual norm 5.252587112411e+01 >>> > > 1 KSP Residual norm 2.072629114336e-12 >>> > > Line search: gnorm after quadratic fit 7.891803681498e+03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.819076698717e+03 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 5.911876424956e+02 lambda=2.4538865368827514e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.688195882303e+02 lambda=6.5764457912135515e-03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.500076295129e+02 lambda=6.5764457912135523e-04 >>> > > Line search: Cubically determined step, current gnorm >>> 2.499390700783e+02 lambda=2.7231956365922875e-04 >>> > > 47 SNES Function norm 2.499390700783e+02 >>> > > 0 KSP Residual norm 4.007648116930e+01 >>> > > 1 KSP Residual norm 5.646654234336e-11 >>> > > Line search: gnorm after quadratic fit 6.276152857499e+03 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 1.418274035925e+03 lambda=5.0000000000000003e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 4.785345842563e+02 lambda=2.5000000000000001e-02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 2.665412152699e+02 lambda=8.0607289886479045e-03 >>> > > Line search: Cubically determined step, current gnorm >>> 2.499109739904e+02 lambda=8.0607289886479045e-04 >>> > > 48 SNES Function norm 2.499109739904e+02 >>> > > 0 KSP Residual norm 1.339756751889e+01 >>> > > 1 KSP Residual norm 2.559175980945e-13 >>> > > Line search: gnorm after quadratic fit 6.052259901869e+02 >>> > > Line search: Cubic step no good, shrinking lambda, current >>> gnorm 3.217431518450e+02 lambda=5.0000000000000003e-02 >>> > > Line search: Cubically determined step, current gnorm >>> 2.496541765916e+02 lambda=7.0239599632283649e-03 >>> > > 49 SNES Function norm 2.496541765916e+02 >>> > > 0 KSP Residual norm 5.340771873687e+00 >>> > > 1 KSP Residual norm 1.207454778077e-13 >>> > > Line search: gnorm after quadratic fit 2.760767095070e+02 >>> > > Line search: Cubically determined step, current gnorm >>> 2.491630276458e+02 lambda=5.0000000000000003e-02 >>> > > 50 SNES Function norm 2.491630276458e+02 >>> > > >>> > > >>> > > On Sat, Aug 26, 2017 at 11:45 PM, Barry Smith >>> wrote: >>> > > >>> > > > On Aug 26, 2017, at 10:43 PM, zakaryah . >>> wrote: >>> > > > >>> > > > Hi Barry - many thanks for taking the time to understand my many >>> problems and providing so much help. >>> > > > >>> > > > The reason I was concerned that I could not alter the linesearch >>> was when I tried to use bt instead of the L-BFGS default, cp, the code >>> crashed with an error like "Could not get Jacobian". Maybe this is an >>> incompatibility like you say, since L-BFGS only uses the initial Jacobian >>> and I never tried setting the scale type. >>> > > > >>> > > > I took your advice and tried to shrink the problem. First I tried >>> shrinking by a factor 1000 but this converged very quickly with all test >>> data I could provide, including the data which was problematic with the >>> large grid. So I settled for a reduction in size by a factor 125. The >>> grid size is 13,230. This is a decent test case because the solver fails >>> to converge with the options I was using before, and it is small enough >>> that I can run it with the options you suggested (-snes_fd_color -snes_type >>> newtonls -snes_monitor -snes_linesearch_monitor -ksp_monitor -pc_type lu). >>> > > > >>> > > > The output is 1800 lines long - how shall I share it? >>> > > >>> > > Just email it, that is small enough for email. >>> > > >>> > > Barry >>> > > >>> > > > >>> > > > >>> > > > >>> > > > >>> > > > On Sat, Aug 26, 2017 at 7:38 PM, Barry Smith >>> wrote: >>> > > > >>> > > > > On Aug 26, 2017, at 5:56 PM, zakaryah . >>> wrote: >>> > > > > >>> > > > > I'm using PETSc's SNES methods to solve PDEs which result from >>> Euler-Lagrange equations for the strain energy of a 3D displacement field. >>> There is an additional term in the Lagrangian which describes external >>> forces which arise from various data sets, and that term contains >>> nonlinearities (field terms higher than linear). The grid has about 1.6e6 >>> elements, and the displacement field has 3 components at each grid element. >>> > > > > >>> > > > > I'm trying to solve a sequence of successively more complicated >>> equations, and the latest equation is failing to converge on some data >>> sets. In particular, the methods were successful for the infinitesimal bulk >>> strain (compression) energy, as well as the full infinitesimal strain >>> energy (bulk + shear), but I'm now trying to generalize to the finite >>> strain, as certain data sets are known to result from displacement fields >>> for which the infinitesimal strain is a poor approximation. >>> > > > > >>> > > > > I'm using a DMDA, closely following example 48, and my preferred >>> solver is L-BFGS. >>> > > > >>> > > > So you are using ? >>> > > > >>> > > > -snes_type qn -snes_qn_type lbfgs >>> > > > >>> > > > > >>> > > > > I have read the FAQs "Why is Newton's method not converging??" >>> and "Why is my iterative linear solver not converging??"? which have raised >>> a number of questions: >>> > > > >>> > > > Quasi Newton methods either don't use Jacobians or use only the >>> initial Jacobian (the idea behind quasi-Newton methods is to approximate >>> Jacobian information from previous iterations without having the user >>> compute a Jacobian at each iteration). With PETSc's qn it only uses the >>> Jacobian if you use the option >>> > > > >>> > > > -snes_qn_scale_type Jacobian >>> > > > >>> > > > otherwise the Jacobian is never computed or used >>> > > > >>> > > > >>> > > > > >>> > > > > Is there documentation for the DMDA/SNES methods somewhere? I >>> don't understand these very well. For example, I am not allocating any >>> matrix for the global Jacobian, and I believe this prevents me from >>> changing the line search. If I'm mistaken I would love to see an example >>> of changing the line search type while using DMDA/SNES. >>> > > > >>> > > > Whether you provide a Jacobian or not is orthogonal to the line >>> search. >>> > > > >>> > > > You should be able to change the line search with >>> > > > >>> > > > -snes_linesearch_type bt or nleqerr or basic or l2 or cp >>> > > > >>> > > > not all of them may work with qn >>> > > > >>> > > > >>> > > > > >>> > > > > I don't know how to interpret the linesearch monitor. Even for >>> problems which are converging properly, the linesearch monitor reports >>> "lssucceed=0" on every iteration. Is this a problem? >>> > > > >>> > > > It returns a 0 if the line search does not believe it has >>> achieved "sufficient decrease" in the function norm (or possibly some other >>> measure of decrease) you should run -snes_linesearch_monitor also with the >>> option -snes_monitor to see what is happening to the function norm >>> > > > >>> > > > For qn you can add the option >>> > > > >>> > > > -snes_qn_monitor >>> > > > >>> > > > to get more detailed monitoring >>> > > > >>> > > > >>> > > > > >>> > > > > I'm also having trouble understanding the methods for >>> troubleshooting. I suspect that I've made an error in the analytical >>> Jacobian, which has a rather large number of non-zero elements, but I have >>> no idea how to use -snes_type test -snes_test_display. The FAQs mention >>> that some troubleshooting tools are more useful for small test problems. >>> How small is small? >>> > > > >>> > > > Tiny, at most a few dozen rows and columns in the Jacobin. >>> > > > >>> > > > You should run without the -snes_test_display information, what >>> does it say? Does it indicate the Jacobian or report there is likely a >>> problem? >>> > > > >>> > > > With DMDA you can also use -snes_fd_color to have PETSc >>> compute the Jacobian for you instead of using your analytical form. If it >>> works with this, but not your Jacobian then your Jacobian is wrong. >>> > > > >>> > > > > When I try to run the program with -snes_type test >>> -snes_test_display, I get errors like: >>> > > > > >>> > > > > [0]PETSC ERROR: Argument out of range [0]PETSC ERROR: Local >>> index 1076396032 too large 4979879 (max) at 0 >>> > > > > >>> > > > > The second size is 1 less than the number of field elements, >>> while the first number seems too large for any aspect of the problem - the >>> Jacobian has at most 59 non-zero columns per row. >>> > > > > >>> > > > > Because I suspect a possible error in the Jacobian, I ran with >>> -snes_mf_operator -pc_type ksp -ksp_ksp_rtol 1e-12 and observed very >>> similar failure to converge (diverging residual) as with the explicit >>> Jacobian. >>> > > > >>> > > > What do you get with -ksp_monitor -ksp_ksp_monitor it sounds >>> like the true Jacobian is either very ill-conditioned or your function >>> evaluation is wrong. >>> > > > >>> > > > > Do I need to set an SNES method which is somehow compatible with >>> the "matrix-free" approach? If I instead use -snes_mf, the problem seems to >>> converge, but horrendously slowly (true residual relative decrease by about >>> 1e-5 per iteration). I suppose this supports my suspicion that the >>> Jacobian is incorrect but doesn't really suggest a solution. >>> > > > > >>> > > > > Is it possible that the analytical Jacobian is correct, but >>> somehow pathological, which causes the SNES to diverge? >>> > > > >>> > > > Yes >>> > > > >>> > > > > Neither the Jacobian nor the function have singularities. >>> > > > > >>> > > > > Thanks for any help you can provide! >>> > > > >>> > > > Try really hard to set up a small problem (like just use a >>> very coarse grid) to experiment with as you try to get convergence. Using a >>> big problem for debugging convergence is a recipe for pain. >>> > > > >>> > > > Also since you have a Jacobian I would start with >>> -snes_fd_color -snes_type ls -snes_monitor -snes_linesearch_monitor >>> -ksp_monitor -pc_type lu (not on a huge problem), what happens? Send the >>> output >>> > > > >>> > > > Barry >>> > > > >>> > > > >>> > > > >>> > > >>> > > >>> > >>> > >>> >>> >> > -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Sun Aug 27 16:48:23 2017 From: bsmith at mcs.anl.gov (Barry Smith) Date: Sun, 27 Aug 2017 16:48:23 -0500 Subject: [petsc-users] A number of questions about DMDA with SNES and Quasi-Newton methods In-Reply-To: References: <020DAED9-AAAD-4741-976B-BB2EF6C79D3F@mcs.anl.gov> <5BF530F6-8D79-47E6-B2C5-B0702FF2AA59@mcs.anl.gov> <7EE84495-4346-4BFB-B9AD-BCAA3C722461@mcs.anl.gov> Message-ID: > On Aug 27, 2017, at 1:23 PM, zakaryah . wrote: > > I ran the smaller grid problem with -snes_test_display -snes_fd_color, and it did not crash (setting -snes_fd_color was apparently a crucial step). The result was: Sorry this isn't testing anything; it is comparing the fd_color to the fd. So it doesn't tell us anything. > > Norm of matrix ratio 0., difference 0. (user-defined state) > > Norm of matrix ratio 0., difference 0. (constant state -1.0) > > which suggests to me that the Jacobian is correct. Is it possible that QN is just a bad approach for this problem, or that I need to adjust the default parameters? > > > On Sun, Aug 27, 2017 at 1:54 PM, zakaryah . wrote: > Is it suspicious that the KSP converges so quickly? I have no experience with how the solvers behave on such small grids. > > Also, I ran the code with -snes_type test on a very small grid (1530 elements). The simpler version of the PDE ran fine, and showed good agreement of the matrices. However, the more complicated version crashes with the following errors: > > Testing hand-coded Jacobian, if the ratio is > > O(1.e-8), the hand-coded Jacobian is probably correct. > > Run with -snes_test_display to show difference > > of hand-coded and finite difference Jacobian. > > [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- > > [0]PETSC ERROR: Argument out of range > > [0]PETSC ERROR: Inserting a new nonzero at (7,0) in the matrix > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. > > [0]PETSC ERROR: Petsc Release Version 3.7.3, Jul, 24, 2016 > > [0]PETSC ERROR: #1 MatSetValues_SeqAIJ() line 484 in /PETSc/build/petsc-3.7.3/src/mat/impls/aij/seq/aij.c > > [0]PETSC ERROR: #2 MatSetValues() line 1190 in /PETSc/build/petsc-3.7.3/src/mat/interface/matrix.c > > [0]PETSC ERROR: #3 MatSetValuesLocal() line 2053 in /PETSc/build/petsc-3.7.3/src/mat/interface/matrix.c > > [0]PETSC ERROR: #4 MatSetValuesStencil() line 1447 in /PETSc/build/petsc-3.7.3/src/mat/interface/matrix.c > > Does this indicate a bug in the Jacobian calculation? I don't think I set values outside of the stencil... > > > On Sun, Aug 27, 2017 at 12:14 AM, zakaryah . wrote: > Sure - it was this: > > mpiexec -n 1 -snes_fd_color -snes_type newtonls -snes_monitor -snes_linesearch_monitor -ksp_monitor -pc_type lu > > On Sun, Aug 27, 2017 at 12:11 AM, Barry Smith wrote: > > > On Aug 26, 2017, at 10:55 PM, zakaryah . wrote: > > > > Yes, except I changed "-snes_type ls" to "-snes_type newtonls" because PETSc complained that ls wasn't a known method. > > Sorry, my memory is not as good as it used to be; but what other options did you use? Send the exact command line. > > > Barry > ' > > > > On Sat, Aug 26, 2017 at 11:52 PM, Barry Smith wrote: > > > > My exact options did you run with? > > > > > On Aug 26, 2017, at 10:48 PM, zakaryah . wrote: > > > > > > Here's the output, from the data set which does not converge with l-bfgs: > > > > > > 0 SNES Function norm 1.370293318432e+04 > > > 0 KSP Residual norm 7.457506389218e+02 > > > 1 KSP Residual norm 2.244764079994e-10 > > > Line search: gnorm after quadratic fit 6.541298279196e+05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.963717927372e+04 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.788909416707e+04 lambda=2.5000000000000001e-02 > > > Line search: Cubically determined step, current gnorm 1.340565762719e+04 lambda=1.2500000000000001e-02 > > > 1 SNES Function norm 1.340565762719e+04 > > > 0 KSP Residual norm 4.096066553372e+02 > > > 1 KSP Residual norm 3.313671167444e-11 > > > Line search: gnorm after quadratic fit 1.113749573695e+06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.406390140546e+05 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.126781917443e+04 lambda=2.5000000000000001e-02 > > > Line search: Cubically determined step, current gnorm 1.272988597973e+04 lambda=1.2500000000000001e-02 > > > 2 SNES Function norm 1.272988597973e+04 > > > 0 KSP Residual norm 8.291344597817e+01 > > > 1 KSP Residual norm 7.182258362182e-12 > > > Line search: gnorm after quadratic fit 1.121913743889e+04 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 3 SNES Function norm 1.121913743889e+04 > > > 0 KSP Residual norm 6.830535877014e+01 > > > 1 KSP Residual norm 3.629826411580e-12 > > > Line search: gnorm after quadratic fit 9.966344973786e+03 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 4 SNES Function norm 9.966344973786e+03 > > > 0 KSP Residual norm 5.137691531345e+01 > > > 1 KSP Residual norm 1.954502098181e-12 > > > Line search: gnorm after quadratic fit 8.905508641232e+03 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 5 SNES Function norm 8.905508641232e+03 > > > 0 KSP Residual norm 4.295019262963e+01 > > > 1 KSP Residual norm 1.581527994925e-12 > > > Line search: gnorm after quadratic fit 7.599173694189e+03 > > > Line search: Quadratically determined step, lambda=1.4157226463489950e-01 > > > 6 SNES Function norm 7.599173694189e+03 > > > 0 KSP Residual norm 3.520472291520e+01 > > > 1 KSP Residual norm 1.169994130568e-12 > > > Line search: gnorm after quadratic fit 6.797214843928e+03 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 7 SNES Function norm 6.797214843928e+03 > > > 0 KSP Residual norm 2.683523206056e+01 > > > 1 KSP Residual norm 9.039858014119e-13 > > > Line search: gnorm after quadratic fit 6.098038917364e+03 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 8 SNES Function norm 6.098038917364e+03 > > > 0 KSP Residual norm 2.300710560681e+01 > > > 1 KSP Residual norm 1.010402303464e-12 > > > Line search: gnorm after quadratic fit 5.486151385552e+03 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 9 SNES Function norm 5.486151385552e+03 > > > 0 KSP Residual norm 2.824628827619e+01 > > > 1 KSP Residual norm 1.009589866569e-12 > > > Line search: gnorm after quadratic fit 4.964991021247e+03 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 10 SNES Function norm 4.964991021247e+03 > > > 0 KSP Residual norm 6.285926028595e+01 > > > 1 KSP Residual norm 2.833546214180e-12 > > > Line search: gnorm after quadratic fit 2.100041391472e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.804051080767e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 4.893296169579e+03 lambda=2.5000000000000001e-02 > > > 11 SNES Function norm 4.893296169579e+03 > > > 0 KSP Residual norm 1.688978282804e+01 > > > 1 KSP Residual norm 5.927677470786e-13 > > > Line search: gnorm after quadratic fit 4.400894622431e+03 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 12 SNES Function norm 4.400894622431e+03 > > > 0 KSP Residual norm 1.481197699600e+01 > > > 1 KSP Residual norm 4.522572128105e-13 > > > Line search: Using full step: fnorm 4.400894622431e+03 gnorm 2.094971849007e+03 > > > 13 SNES Function norm 2.094971849007e+03 > > > 0 KSP Residual norm 3.514164563318e+00 > > > 1 KSP Residual norm 3.022385947499e-13 > > > Line search: gnorm after quadratic fit 1.687641025382e+03 > > > Line search: Quadratically determined step, lambda=2.0307116693368590e-01 > > > 14 SNES Function norm 1.687641025382e+03 > > > 0 KSP Residual norm 2.138591884686e+00 > > > 1 KSP Residual norm 4.023500814078e-14 > > > Line search: Using full step: fnorm 1.687641025382e+03 gnorm 1.131934218470e+03 > > > 15 SNES Function norm 1.131934218470e+03 > > > 0 KSP Residual norm 3.245035110327e+00 > > > 1 KSP Residual norm 1.293626215269e-13 > > > Line search: Using full step: fnorm 1.131934218470e+03 gnorm 7.340573607307e+02 > > > 16 SNES Function norm 7.340573607307e+02 > > > 0 KSP Residual norm 1.957698957904e+00 > > > 1 KSP Residual norm 3.444648967078e-13 > > > Line search: Using full step: fnorm 7.340573607307e+02 gnorm 5.024723505168e+02 > > > 17 SNES Function norm 5.024723505168e+02 > > > 0 KSP Residual norm 2.510538703839e+00 > > > 1 KSP Residual norm 8.570440675253e-14 > > > Line search: gnorm after quadratic fit 4.548776456608e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 18 SNES Function norm 4.548776456608e+02 > > > 0 KSP Residual norm 6.741705718178e-01 > > > 1 KSP Residual norm 1.650556120809e-14 > > > Line search: Using full step: fnorm 4.548776456608e+02 gnorm 1.351189086642e+02 > > > 19 SNES Function norm 1.351189086642e+02 > > > 0 KSP Residual norm 7.653741241950e+00 > > > 1 KSP Residual norm 8.326848236950e-14 > > > Line search: gnorm after quadratic fit 4.215455105006e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.889750369356e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.358691836999e+02 lambda=1.0303015930243279e-02 > > > Line search: Cubically determined step, current gnorm 1.348911963390e+02 lambda=3.5279526770504110e-03 > > > 20 SNES Function norm 1.348911963390e+02 > > > 0 KSP Residual norm 4.209281176918e+00 > > > 1 KSP Residual norm 1.233232881375e-13 > > > Line search: gnorm after quadratic fit 1.860023264470e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.413911132196e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.339597869053e+02 lambda=1.5787957598629023e-02 > > > 21 SNES Function norm 1.339597869053e+02 > > > 0 KSP Residual norm 1.718484765841e+00 > > > 1 KSP Residual norm 6.666016296543e-14 > > > Line search: gnorm after quadratic fit 1.326878521472e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 22 SNES Function norm 1.326878521472e+02 > > > 0 KSP Residual norm 1.515373499919e+00 > > > 1 KSP Residual norm 2.259154130795e-12 > > > Line search: gnorm after quadratic fit 1.226907316391e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 23 SNES Function norm 1.226907316391e+02 > > > 0 KSP Residual norm 1.080252936903e+00 > > > 1 KSP Residual norm 1.847020526683e-14 > > > Line search: gnorm after quadratic fit 1.163632111851e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 24 SNES Function norm 1.163632111851e+02 > > > 0 KSP Residual norm 2.491746958382e+00 > > > 1 KSP Residual norm 6.389134193637e-14 > > > Line search: gnorm after quadratic fit 1.345487153563e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.169738363622e+02 lambda=4.4108900954515480e-02 > > > Line search: Cubically determined step, current gnorm 1.152177638108e+02 lambda=1.9997442889243631e-02 > > > 25 SNES Function norm 1.152177638108e+02 > > > 0 KSP Residual norm 5.364385501004e+00 > > > 1 KSP Residual norm 8.457149562463e-14 > > > Line search: gnorm after quadratic fit 2.722095758964e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.480946353374e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.150680255994e+02 lambda=6.3560128131639167e-03 > > > 26 SNES Function norm 1.150680255994e+02 > > > 0 KSP Residual norm 4.302025268263e+00 > > > 1 KSP Residual norm 1.017526937941e-13 > > > Line search: gnorm after quadratic fit 1.956300983573e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.318600522939e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.147123505014e+02 lambda=7.6060788653548803e-03 > > > 27 SNES Function norm 1.147123505014e+02 > > > 0 KSP Residual norm 6.195463111324e+00 > > > 1 KSP Residual norm 1.235283250361e-13 > > > Line search: gnorm after quadratic fit 3.324821547049e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.612593208504e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.147389525772e+02 lambda=6.1750939181374294e-03 > > > Line search: Cubically determined step, current gnorm 1.145411432123e+02 lambda=3.0078592586792975e-03 > > > 28 SNES Function norm 1.145411432123e+02 > > > 0 KSP Residual norm 1.454704250187e+01 > > > 1 KSP Residual norm 2.368485174123e-13 > > > Line search: gnorm after quadratic fit 1.216293873116e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.796524621727e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.359314163651e+02 lambda=1.4867675803955788e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.146009802557e+02 lambda=1.4867675803955788e-03 > > > Line search: Cubically determined step, current gnorm 1.145096815033e+02 lambda=5.5250912472932839e-04 > > > 29 SNES Function norm 1.145096815033e+02 > > > 0 KSP Residual norm 3.430451345093e+01 > > > 1 KSP Residual norm 1.069396165938e-12 > > > Line search: gnorm after quadratic fit 1.161329407098e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.260690718050e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.696806489042e+02 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.960149915648e+02 lambda=1.1276129246469476e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.158113641658e+02 lambda=1.5873910451430554e-03 > > > Line search: Cubically determined step, current gnorm 1.145062232916e+02 lambda=1.5873910451430555e-04 > > > 30 SNES Function norm 1.145062232916e+02 > > > 0 KSP Residual norm 2.662578971526e+01 > > > 1 KSP Residual norm 5.464011789728e-13 > > > Line search: gnorm after quadratic fit 4.375119254490e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.038018103928e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.169328002874e+02 lambda=2.3789161387159519e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.262835432714e+02 lambda=5.9737415571960795e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.145626045197e+02 lambda=5.9737415571960802e-04 > > > Line search: Cubically determined step, current gnorm 1.144968604079e+02 lambda=1.6421773527706333e-04 > > > 31 SNES Function norm 1.144968604079e+02 > > > 0 KSP Residual norm 6.322033697338e+01 > > > 1 KSP Residual norm 1.507157991448e-12 > > > Line search: gnorm after quadratic fit 5.809243699277e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.460487584142e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.893183483197e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.960337007072e+02 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.771527792790e+02 lambda=5.3912931685137378e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.150137639707e+02 lambda=5.3912931685137376e-04 > > > Line search: Cubically determined step, current gnorm 1.144964484571e+02 lambda=5.3912931685137380e-05 > > > 32 SNES Function norm 1.144964484571e+02 > > > 0 KSP Residual norm 3.859510930996e+01 > > > 1 KSP Residual norm 8.069118044382e-13 > > > Line search: gnorm after quadratic fit 1.106329930525e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.155884463041e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.933963819094e+02 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.849629797377e+02 lambda=9.7744286136270241e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.150857687050e+02 lambda=9.7744286136270254e-04 > > > Line search: Cubically determined step, current gnorm 1.144922906340e+02 lambda=9.7744286136270254e-05 > > > 33 SNES Function norm 1.144922906340e+02 > > > 0 KSP Residual norm 4.952038022394e+01 > > > 1 KSP Residual norm 7.460263245424e-13 > > > Line search: gnorm after quadratic fit 3.005091127220e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.229308416025e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.138600794682e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.390856262238e+02 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.394997214983e+02 lambda=4.4582997750629580e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.146836358799e+02 lambda=4.4582997750629581e-04 > > > Line search: Cubically determined step, current gnorm 1.144895966587e+02 lambda=4.7644082443915877e-05 > > > 34 SNES Function norm 1.144895966587e+02 > > > 0 KSP Residual norm 1.146914786457e+02 > > > 1 KSP Residual norm 4.791627042400e-12 > > > Line search: gnorm after quadratic fit 2.601294145944e+05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.324148513778e+04 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.247478406023e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.200340900661e+03 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.696223112300e+02 lambda=6.1514413845115794e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.342365431983e+02 lambda=1.7502929694284564e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.146686063035e+02 lambda=1.7502929694284566e-04 > > > Line search: Cubically determined step, current gnorm 1.144895868489e+02 lambda=1.7502929694284566e-05 > > > 35 SNES Function norm 1.144895868489e+02 > > > 0 KSP Residual norm 6.311017209658e+01 > > > 1 KSP Residual norm 8.384445939117e-13 > > > Line search: gnorm after quadratic fit 5.781533400572e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.419557746031e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.886081770030e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.945810143740e+02 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.767820854837e+02 lambda=5.3859001959289735e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.150034040559e+02 lambda=5.3859001959289732e-04 > > > Line search: Cubically determined step, current gnorm 1.144891501665e+02 lambda=5.3859001959289732e-05 > > > 36 SNES Function norm 1.144891501665e+02 > > > 0 KSP Residual norm 3.880748384332e+01 > > > 1 KSP Residual norm 6.400339290453e-13 > > > Line search: gnorm after quadratic fit 1.122504184426e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.180728237366e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.987870621566e+02 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.863711604331e+02 lambda=9.8150771384688824e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.150916783781e+02 lambda=9.8150771384688824e-04 > > > Line search: Cubically determined step, current gnorm 1.144850837411e+02 lambda=9.8150771384688832e-05 > > > 37 SNES Function norm 1.144850837411e+02 > > > 0 KSP Residual norm 4.811537498557e+01 > > > 1 KSP Residual norm 9.738167670242e-13 > > > Line search: gnorm after quadratic fit 2.784098355218e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.885118868254e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.074843354348e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.255202820836e+02 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.365202996130e+02 lambda=4.3204204582016374e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.146504919412e+02 lambda=4.3204204582016374e-04 > > > Line search: Cubically determined step, current gnorm 1.144822306241e+02 lambda=5.0376546850227848e-05 > > > 38 SNES Function norm 1.144822306241e+02 > > > 0 KSP Residual norm 1.120914002482e+02 > > > 1 KSP Residual norm 5.452125292284e-12 > > > Line search: gnorm after quadratic fit 2.427186680567e+05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.112196656857e+04 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.967397366072e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.149551659770e+03 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.529630886791e+02 lambda=6.0885216927030559e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.315267519231e+02 lambda=1.6656233536183130e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.146353659250e+02 lambda=1.6656233536183130e-04 > > > Line search: Cubically determined step, current gnorm 1.144820487391e+02 lambda=1.6656233536183130e-05 > > > 39 SNES Function norm 1.144820487391e+02 > > > 0 KSP Residual norm 7.182416170980e+01 > > > 1 KSP Residual norm 1.292147133333e-12 > > > Line search: gnorm after quadratic fit 8.255331293322e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.302939895170e+04 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.501228089911e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.185010378583e+02 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.088179821424e+02 lambda=5.7489510178867142e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.168272901121e+02 lambda=9.7452649444612811e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144951972300e+02 lambda=9.7452649444612822e-05 > > > Line search: Cubically determined step, current gnorm 1.144807676687e+02 lambda=2.2399506502463798e-05 > > > 40 SNES Function norm 1.144807676687e+02 > > > 0 KSP Residual norm 1.728679810285e+02 > > > 1 KSP Residual norm 3.878068639716e-12 > > > Line search: gnorm after quadratic fit 9.011020578535e+05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.111818830011e+05 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.504789858103e+04 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.754312133162e+03 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.212492111975e+02 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.199969180537e+02 lambda=2.6424184504193135e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.154794639440e+02 lambda=2.6424184504193136e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144880673342e+02 lambda=2.6424184504193136e-05 > > > Line search: Cubically determined step, current gnorm 1.144805461570e+02 lambda=3.8712107591125690e-06 > > > 41 SNES Function norm 1.144805461570e+02 > > > 0 KSP Residual norm 4.162780846202e+02 > > > 1 KSP Residual norm 1.732341544934e-11 > > > Line search: gnorm after quadratic fit 1.355673864369e+07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.747523002884e+06 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.342205048417e+05 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.425635699680e+04 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.882150659178e+03 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.259664786336e+03 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.653670676209e+02 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.453655830144e+02 lambda=5.8237455565260388e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.147659525018e+02 lambda=5.8237455565260393e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144827915995e+02 lambda=5.8237455565260400e-06 > > > Line search: Cubically determined step, current gnorm 1.144805080017e+02 lambda=6.6689295146509104e-07 > > > 42 SNES Function norm 1.144805080017e+02 > > > 0 KSP Residual norm 1.004135512581e+03 > > > 1 KSP Residual norm 3.867626041000e-09 > > > Line search: gnorm after quadratic fit 1.832578994882e+08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.269698278878e+07 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.792476589915e+06 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.420660371083e+05 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.321686926168e+04 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.548358078234e+03 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.429504802276e+03 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.317723385004e+02 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.460079723095e+02 lambda=2.5078917343692407e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.147908977725e+02 lambda=2.5078917343692408e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144833604238e+02 lambda=2.5078917343692412e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144805106824e+02 lambda=2.5078917343692411e-07 > > > Line search: Cubically determined step, current gnorm 1.144805014337e+02 lambda=1.1468707119027746e-07 > > > 43 SNES Function norm 1.144805014337e+02 > > > 0 KSP Residual norm 2.418614573592e+03 > > > 1 KSP Residual norm 6.085078742847e-10 > > > Line search: gnorm after quadratic fit 2.598476259775e+09 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.262759415873e+08 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.116845970403e+07 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.250465130250e+06 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.863493884574e+05 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.501468163771e+04 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.482658980483e+04 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.802395557883e+03 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.788149582374e+02 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.248828337038e+02 lambda=1.8333058767960295e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.186285836222e+02 lambda=3.7550993478654105e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.145209710139e+02 lambda=3.7550993478654107e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144808670668e+02 lambda=3.7550993478654111e-07 > > > Line search: Cubically determined step, current gnorm 1.144805012252e+02 lambda=3.7550993478654114e-08 > > > 44 SNES Function norm 1.144805012252e+02 > > > 0 KSP Residual norm 1.432476672735e+03 > > > 1 KSP Residual norm 7.850524783892e-11 > > > Line search: gnorm after quadratic fit 5.336191593632e+08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.625576866625e+07 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.181408387845e+06 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.003310644422e+06 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.236384273292e+05 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.658430638069e+04 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.977463068161e+03 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.674238499253e+02 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.333616820791e+02 lambda=3.3764776729281175e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.161349153752e+02 lambda=4.0497161764116874e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144966925969e+02 lambda=4.0497161764116874e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144806214839e+02 lambda=4.0497161764116878e-07 > > > Line search: Cubically determined step, current gnorm 1.144804979966e+02 lambda=5.6339112427782378e-08 > > > 45 SNES Function norm 1.144804979966e+02 > > > 0 KSP Residual norm 3.453401579761e+03 > > > 1 KSP Residual norm 4.197968028126e-09 > > > Line search: gnorm after quadratic fit 7.554006183767e+09 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.471974940372e+08 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.191613865049e+08 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.509784334249e+07 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.943752478560e+06 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.597601716755e+05 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.775572331075e+04 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.418045407608e+03 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.357066758731e+03 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.859267839080e+02 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.501494912160e+02 lambda=7.5160826909319168e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.148144926477e+02 lambda=7.5160826909319171e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144837498478e+02 lambda=7.5160826909319179e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144805227746e+02 lambda=7.5160826909319182e-08 > > > Line search: Cubically determined step, current gnorm 1.144804974438e+02 lambda=9.6864021663644795e-09 > > > 46 SNES Function norm 1.144804974438e+02 > > > 0 KSP Residual norm 8.345139428850e+03 > > > 1 KSP Residual norm 1.027819754739e-09 > > > Line search: gnorm after quadratic fit 1.061319903906e+11 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.325012985379e+10 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.652236226640e+09 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.055533971630e+08 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.546607716763e+07 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.134442858835e+06 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.839168570687e+05 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.830568178626e+04 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.201776786081e+03 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.540520468013e+03 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.573504890506e+02 lambda=9.7656250000000005e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.516203908013e+02 lambda=3.2703670177372021e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.148480075676e+02 lambda=3.2703670177372022e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144841475328e+02 lambda=3.2703670177372023e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144805305720e+02 lambda=3.2703670177372021e-08 > > > Line search: Cubically determined step, current gnorm 1.144804974367e+02 lambda=3.2703670177372025e-09 > > > 47 SNES Function norm 1.144804974367e+02 > > > 0 KSP Residual norm 4.668983500382e+03 > > > 1 KSP Residual norm 1.398997665317e-09 > > > Line search: gnorm after quadratic fit 1.865309565532e+10 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.336975299727e+09 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.934905088739e+08 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.704520478641e+07 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.728477809448e+06 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.193001670096e+05 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.610673238239e+04 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.354711683605e+04 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.589557246433e+03 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.367851970709e+02 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.136930269795e+02 lambda=9.0316845802227864e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.172186635069e+02 lambda=1.5831613287181393e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.145074017254e+02 lambda=1.5831613287181394e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144807499816e+02 lambda=1.5831613287181396e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144804983345e+02 lambda=1.5831613287181397e-08 > > > Line search: Cubically determined step, current gnorm 1.144804971346e+02 lambda=5.2932921109871310e-09 > > > 48 SNES Function norm 1.144804971346e+02 > > > 0 KSP Residual norm 1.132678078317e+04 > > > 1 KSP Residual norm 2.477518733314e-10 > > > Line search: gnorm after quadratic fit 2.654659022365e+11 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.315296223725e+10 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.136635677074e+09 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.152507060235e+08 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.397060094478e+07 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.898362012287e+06 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.685179520906e+05 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.194040779842e+05 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.606415730227e+04 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.902698091972e+03 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.521549384652e+02 lambda=9.7656250000000005e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.288999778994e+02 lambda=4.1899746703195281e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.157880829786e+02 lambda=4.5470218451893824e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144935741206e+02 lambda=4.5470218451893828e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144806232638e+02 lambda=4.5470218451893831e-08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144804979250e+02 lambda=4.5470218451893835e-09 > > > Line search: Cubically determined step, current gnorm 1.144804970825e+02 lambda=9.0293679903918216e-10 > > > 49 SNES Function norm 1.144804970825e+02 > > > 0 KSP Residual norm 2.712544829144e+04 > > > 1 KSP Residual norm 4.949246309677e-09 > > > Line search: gnorm after quadratic fit 3.650846005745e+12 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.565321055911e+11 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.711080201118e+10 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.150022242308e+09 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.965954117985e+08 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.128096393645e+08 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.429702091584e+07 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.841819946536e+06 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.465032956946e+05 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.594210253794e+04 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.141110278944e+03 lambda=9.7656250000000005e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.306952279045e+03 lambda=4.8828125000000003e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.754164864338e+02 lambda=2.4414062500000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.476861367158e+02 lambda=9.2451761406722810e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.147929263780e+02 lambda=9.2451761406722810e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144836022952e+02 lambda=9.2451761406722821e-08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144805271860e+02 lambda=9.2451761406722831e-09 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144804972895e+02 lambda=9.2451761406722839e-10 > > > Line search: Cubically determined step, current gnorm 1.144804970737e+02 lambda=1.5633616333063305e-10 > > > 50 SNES Function norm 1.144804970737e+02 > > > 0 SNES Function norm 2.308693894796e+03 > > > 0 KSP Residual norm 8.981999720532e+00 > > > 1 KSP Residual norm 2.363170936183e-13 > > > Line search: Using full step: fnorm 2.308693894796e+03 gnorm 7.571661187318e+02 > > > 1 SNES Function norm 7.571661187318e+02 > > > 0 KSP Residual norm 2.149614048903e+00 > > > 1 KSP Residual norm 9.511247057888e-13 > > > Line search: Using full step: fnorm 7.571661187318e+02 gnorm 4.450081004997e+02 > > > 2 SNES Function norm 4.450081004997e+02 > > > 0 KSP Residual norm 1.706469075123e+01 > > > 1 KSP Residual norm 5.803815175472e-13 > > > Line search: gnorm after quadratic fit 1.510518198899e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.850796532980e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.515983139755e+02 lambda=2.0602556887689423e-02 > > > Line search: Cubically determined step, current gnorm 4.434800867235e+02 lambda=8.2396279492937211e-03 > > > 3 SNES Function norm 4.434800867235e+02 > > > 0 KSP Residual norm 3.208587171626e+00 > > > 1 KSP Residual norm 1.099072610659e-13 > > > Line search: gnorm after quadratic fit 4.080637194736e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 4 SNES Function norm 4.080637194736e+02 > > > 0 KSP Residual norm 8.136557176540e+00 > > > 1 KSP Residual norm 8.800137844173e-13 > > > Line search: gnorm after quadratic fit 5.261656549654e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.131114070934e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 4.031614746044e+02 lambda=2.4674842039461482e-02 > > > 5 SNES Function norm 4.031614746044e+02 > > > 0 KSP Residual norm 7.609918907567e+00 > > > 1 KSP Residual norm 1.613159932655e-13 > > > Line search: gnorm after quadratic fit 5.353908064984e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.110480554132e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 3.991168240716e+02 lambda=2.3079500036735322e-02 > > > 6 SNES Function norm 3.991168240716e+02 > > > 0 KSP Residual norm 3.800845472041e+00 > > > 1 KSP Residual norm 4.841682188278e-13 > > > Line search: gnorm after quadratic fit 3.787886582952e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 7 SNES Function norm 3.787886582952e+02 > > > 0 KSP Residual norm 1.892621919219e+00 > > > 1 KSP Residual norm 3.576655371800e-12 > > > Line search: gnorm after quadratic fit 3.440181918909e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 8 SNES Function norm 3.440181918909e+02 > > > 0 KSP Residual norm 3.559759789147e+00 > > > 1 KSP Residual norm 8.347521826622e-13 > > > Line search: gnorm after quadratic fit 3.287993515195e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 9 SNES Function norm 3.287993515195e+02 > > > 0 KSP Residual norm 1.825073540507e+00 > > > 1 KSP Residual norm 8.352745008123e-14 > > > Line search: Using full step: fnorm 3.287993515195e+02 gnorm 2.710650507416e+02 > > > 10 SNES Function norm 2.710650507416e+02 > > > 0 KSP Residual norm 7.568432945608e-01 > > > 1 KSP Residual norm 2.780715252274e-14 > > > Line search: Using full step: fnorm 2.710650507416e+02 gnorm 1.513359047342e+02 > > > 11 SNES Function norm 1.513359047342e+02 > > > 0 KSP Residual norm 9.387460484575e+00 > > > 1 KSP Residual norm 7.091233040676e-13 > > > Line search: gnorm after quadratic fit 3.998857979851e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.060972049714e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.512140169420e+02 lambda=5.4338709720680610e-03 > > > 12 SNES Function norm 1.512140169420e+02 > > > 0 KSP Residual norm 4.399424360499e+00 > > > 1 KSP Residual norm 1.614362118182e-13 > > > Line search: gnorm after quadratic fit 1.913552832643e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.559719302467e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.499985374733e+02 lambda=1.7102027220313589e-02 > > > 13 SNES Function norm 1.499985374733e+02 > > > 0 KSP Residual norm 3.740397849742e+00 > > > 1 KSP Residual norm 8.986775577006e-13 > > > Line search: gnorm after quadratic fit 1.764118876632e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.522381536119e+02 lambda=4.8196830215713270e-02 > > > Line search: Cubically determined step, current gnorm 1.486175880390e+02 lambda=1.8881300948189364e-02 > > > 14 SNES Function norm 1.486175880390e+02 > > > 0 KSP Residual norm 6.067973818528e+00 > > > 1 KSP Residual norm 4.527845229549e-13 > > > Line search: gnorm after quadratic fit 2.514021299115e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.679972156573e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.481015724304e+02 lambda=9.0116621678703428e-03 > > > 15 SNES Function norm 1.481015724304e+02 > > > 0 KSP Residual norm 6.108754994263e+00 > > > 1 KSP Residual norm 2.557635976440e-13 > > > Line search: gnorm after quadratic fit 2.458081150104e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.681837029397e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.476148340442e+02 lambda=7.9580911933571953e-03 > > > 16 SNES Function norm 1.476148340442e+02 > > > 0 KSP Residual norm 7.914946163932e+00 > > > 1 KSP Residual norm 1.512066885699e-13 > > > Line search: gnorm after quadratic fit 3.458938604598e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.883018868359e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.474286108114e+02 lambda=6.7262521208543979e-03 > > > 17 SNES Function norm 1.474286108114e+02 > > > 0 KSP Residual norm 5.285449532689e+00 > > > 1 KSP Residual norm 6.693733977456e-12 > > > Line search: gnorm after quadratic fit 2.170263102661e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.607560548008e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.467785507822e+02 lambda=9.9244383205188240e-03 > > > 18 SNES Function norm 1.467785507822e+02 > > > 0 KSP Residual norm 8.124903695635e+00 > > > 1 KSP Residual norm 2.322439601127e-11 > > > Line search: gnorm after quadratic fit 3.589716592364e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.907315184877e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.466341888638e+02 lambda=6.5538271222582893e-03 > > > 19 SNES Function norm 1.466341888638e+02 > > > 0 KSP Residual norm 5.253550718343e+00 > > > 1 KSP Residual norm 1.575657996883e-12 > > > Line search: gnorm after quadratic fit 2.155795776725e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.598564001687e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.459869404602e+02 lambda=9.9195822632931301e-03 > > > 20 SNES Function norm 1.459869404602e+02 > > > 0 KSP Residual norm 8.405987790193e+00 > > > 1 KSP Residual norm 2.046159481178e-13 > > > Line search: gnorm after quadratic fit 3.767908298426e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.941885062002e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.458995232755e+02 lambda=6.4359684554015136e-03 > > > 21 SNES Function norm 1.458995232755e+02 > > > 0 KSP Residual norm 5.036348246593e+00 > > > 1 KSP Residual norm 3.645081669075e-13 > > > Line search: gnorm after quadratic fit 2.083222977519e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.575737508694e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.452039802458e+02 lambda=1.0554092389542354e-02 > > > 22 SNES Function norm 1.452039802458e+02 > > > 0 KSP Residual norm 8.562292355998e+00 > > > 1 KSP Residual norm 3.256332645483e-13 > > > Line search: gnorm after quadratic fit 3.869470823355e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.959483128249e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.451523830598e+02 lambda=6.3780526507799607e-03 > > > 23 SNES Function norm 1.451523830598e+02 > > > 0 KSP Residual norm 4.919667503862e+00 > > > 1 KSP Residual norm 4.823931177115e-13 > > > Line search: gnorm after quadratic fit 2.042891039525e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.560623102934e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.444331916523e+02 lambda=1.0890355421223689e-02 > > > 24 SNES Function norm 1.444331916523e+02 > > > 0 KSP Residual norm 8.727282395369e+00 > > > 1 KSP Residual norm 7.090683582186e-13 > > > Line search: gnorm after quadratic fit 3.977929422821e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.978556223200e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.444215965394e+02 lambda=6.3477766966048947e-03 > > > 25 SNES Function norm 1.444215965394e+02 > > > 0 KSP Residual norm 4.759732971179e+00 > > > 1 KSP Residual norm 7.539889498211e-13 > > > Line search: gnorm after quadratic fit 1.990589649135e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.542648241555e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.436629416941e+02 lambda=1.1434720389464151e-02 > > > 26 SNES Function norm 1.436629416941e+02 > > > 0 KSP Residual norm 8.844861828477e+00 > > > 1 KSP Residual norm 4.372001279689e-13 > > > Line search: gnorm after quadratic fit 4.055598972133e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.990820671396e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.436827663113e+02 lambda=6.3302081701296859e-03 > > > Line search: Cubically determined step, current gnorm 1.434397789472e+02 lambda=3.1285674619640730e-03 > > > 27 SNES Function norm 1.434397789472e+02 > > > 0 KSP Residual norm 2.168630760128e+01 > > > 1 KSP Residual norm 3.975838928402e-13 > > > Line search: gnorm after quadratic fit 1.655681371309e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.972331169594e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.804118272840e+02 lambda=1.6710557456633125e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.435928635079e+02 lambda=1.6710557456633126e-03 > > > Line search: Cubically determined step, current gnorm 1.434032742903e+02 lambda=5.1357350159978810e-04 > > > 28 SNES Function norm 1.434032742903e+02 > > > 0 KSP Residual norm 5.259508821923e+01 > > > 1 KSP Residual norm 1.358381204928e-11 > > > Line search: gnorm after quadratic fit 1.908330224731e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.431279702545e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.060945045253e+02 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.791318323447e+02 lambda=1.2124172979783788e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.491140019897e+02 lambda=2.6952165802905347e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434246250245e+02 lambda=2.6952165802905350e-04 > > > Line search: Cubically determined step, current gnorm 1.433970449422e+02 lambda=8.6980371578986910e-05 > > > 29 SNES Function norm 1.433970449422e+02 > > > 0 KSP Residual norm 1.326287161615e+02 > > > 1 KSP Residual norm 5.692176796134e-12 > > > Line search: gnorm after quadratic fit 2.077891749832e+05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.654187989332e+04 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.213029457851e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.001385334742e+03 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.323976827250e+02 lambda=5.9607661619885998e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.489839529892e+02 lambda=1.0476257410701045e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434396736634e+02 lambda=1.0476257410701046e-04 > > > Line search: Cubically determined step, current gnorm 1.433960671821e+02 lambda=1.3664867646895530e-05 > > > 30 SNES Function norm 1.433960671821e+02 > > > 0 KSP Residual norm 3.320710360189e+02 > > > 1 KSP Residual norm 1.365660123102e-11 > > > Line search: gnorm after quadratic fit 3.597335441013e+06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.714766420450e+05 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.566809766217e+04 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.038660363150e+04 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.026997416957e+03 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.382653551072e+02 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.071747386385e+02 lambda=1.3384948046761360e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.439693866777e+02 lambda=1.3384948046761360e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434000505249e+02 lambda=1.3384948046761361e-05 > > > Line search: Cubically determined step, current gnorm 1.433959111179e+02 lambda=2.1771867000079373e-06 > > > 31 SNES Function norm 1.433959111179e+02 > > > 0 KSP Residual norm 8.385024273664e+02 > > > 1 KSP Residual norm 2.688330817732e-11 > > > Line search: gnorm after quadratic fit 5.487352481970e+07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.776642694838e+06 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.310551423141e+05 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.023322644608e+05 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.368662233379e+04 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.472194884015e+03 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.718801059897e+02 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.274234972424e+02 lambda=6.3064412238487922e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.442194384053e+02 lambda=6.3064412238487925e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434033578642e+02 lambda=6.3064412238487927e-06 > > > Line search: Cubically determined step, current gnorm 1.433959042208e+02 lambda=6.3064412238487929e-07 > > > 32 SNES Function norm 1.433959042208e+02 > > > 0 KSP Residual norm 5.310191626867e+02 > > > 1 KSP Residual norm 2.270033897601e-10 > > > Line search: gnorm after quadratic fit 1.447633783740e+07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.859761774309e+06 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.472992503503e+05 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.557594026810e+04 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.969012939380e+03 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.269212161982e+03 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.859005100842e+02 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.695095262046e+02 lambda=5.4509037994531233e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.436389958907e+02 lambda=5.4509037994531237e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433976258223e+02 lambda=5.4509037994531242e-06 > > > Line search: Cubically determined step, current gnorm 1.433958431980e+02 lambda=8.5124820362933632e-07 > > > 33 SNES Function norm 1.433958431980e+02 > > > 0 KSP Residual norm 1.341142541825e+03 > > > 1 KSP Residual norm 4.194815344365e-11 > > > Line search: gnorm after quadratic fit 2.256410317099e+08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.797696259877e+07 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.447237377751e+06 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.221898175722e+05 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.260244723327e+04 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.539148524881e+03 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.558034531173e+03 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.788188892302e+02 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.753621043454e+02 lambda=2.4427125599600652e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.437122397600e+02 lambda=2.4427125599600654e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433986985128e+02 lambda=2.4427125599600655e-06 > > > Line search: Cubically determined step, current gnorm 1.433958402293e+02 lambda=2.4427125599600656e-07 > > > 34 SNES Function norm 1.433958402293e+02 > > > 0 KSP Residual norm 8.620962950418e+02 > > > 1 KSP Residual norm 4.517777375659e-11 > > > Line search: gnorm after quadratic fit 6.134442313460e+07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.790495969255e+06 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.008365220843e+06 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.364572513478e+05 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.037891335918e+04 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.640571521199e+03 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.472549649319e+02 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.906041216274e+02 lambda=7.6348458761785112e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.504925859329e+02 lambda=1.7740973415567094e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434632637071e+02 lambda=1.7740973415567094e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433962847027e+02 lambda=1.7740973415567095e-06 > > > Line search: Cubically determined step, current gnorm 1.433958170795e+02 lambda=3.2293255704969003e-07 > > > 35 SNES Function norm 1.433958170795e+02 > > > 0 KSP Residual norm 2.177497039945e+03 > > > 1 KSP Residual norm 8.546235181505e-11 > > > Line search: gnorm after quadratic fit 9.689178330938e+08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.204850731541e+08 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.491460480376e+07 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.833699292784e+06 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.246639021599e+05 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.860166571872e+04 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.484329051490e+03 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.050411687443e+03 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.488366972009e+02 lambda=3.7767265396089055e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.508326035050e+02 lambda=7.2725649346261757e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434696063559e+02 lambda=7.2725649346261764e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433964618996e+02 lambda=7.2725649346261768e-07 > > > Line search: Cubically determined step, current gnorm 1.433958141405e+02 lambda=7.2725649346261771e-08 > > > 36 SNES Function norm 1.433958141405e+02 > > > 0 KSP Residual norm 2.164813477994e+03 > > > 1 KSP Residual norm 1.148881458292e-10 > > > Line search: gnorm after quadratic fit 9.626940870744e+08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.210459267934e+08 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.531855101756e+07 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.966826097072e+06 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.611808255272e+05 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.746062783262e+04 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.252259871244e+03 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.319447372021e+03 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.963055448218e+02 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.719034797105e+02 lambda=1.3935000445038475e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.436664111092e+02 lambda=1.3935000445038476e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433983336239e+02 lambda=1.3935000445038476e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958213497e+02 lambda=1.3935000445038476e-07 > > > Line search: Cubically determined step, current gnorm 1.433958104705e+02 lambda=5.1202466521517630e-08 > > > 37 SNES Function norm 1.433958104705e+02 > > > 0 KSP Residual norm 5.470482746849e+03 > > > 1 KSP Residual norm 2.077456833170e-10 > > > Line search: gnorm after quadratic fit 1.541335606193e+10 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.922526157954e+09 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.393079394383e+08 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.967573549050e+07 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.657319925168e+06 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.479516204895e+05 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.573399122917e+04 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.931177424479e+03 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.619710606187e+03 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.924551713717e+02 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.786095404459e+02 lambda=6.2808469554243522e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.437467476469e+02 lambda=6.2808469554243527e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433992463439e+02 lambda=6.2808469554243527e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958367271e+02 lambda=6.2808469554243525e-08 > > > Line search: Cubically determined step, current gnorm 1.433958098948e+02 lambda=8.0208105170108588e-09 > > > 38 SNES Function norm 1.433958098948e+02 > > > 0 KSP Residual norm 1.380568582849e+04 > > > 1 KSP Residual norm 3.830866223513e-10 > > > Line search: gnorm after quadratic fit 2.484973518314e+11 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.108953896984e+10 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.893104137528e+09 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.884003910853e+08 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.150765563542e+07 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.811161146103e+06 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.011017986781e+06 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.368084343451e+05 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.042876665700e+04 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.648735196752e+03 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.489051252413e+02 lambda=9.7656250000000005e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.910677756717e+02 lambda=4.7728537787817724e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.505452645186e+02 lambda=1.1099980464343249e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434658984864e+02 lambda=1.1099980464343249e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433964956476e+02 lambda=1.1099980464343249e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958153212e+02 lambda=1.1099980464343250e-08 > > > Line search: Cubically determined step, current gnorm 1.433958098048e+02 lambda=1.2587012037197021e-09 > > > 39 SNES Function norm 1.433958098048e+02 > > > 0 KSP Residual norm 3.492284741552e+04 > > > 1 KSP Residual norm 2.459788921244e-09 > > > Line search: gnorm after quadratic fit 4.017424324975e+12 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.020053801097e+11 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.270768402853e+10 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.827801904036e+09 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.758550488105e+08 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.213492627852e+08 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.502191365805e+07 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.846947104704e+06 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.262850216093e+05 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.879926646684e+04 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.510203332079e+03 lambda=9.7656250000000005e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.055028679619e+03 lambda=4.8828125000000003e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.503903269554e+02 lambda=2.3633949212111800e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.510245991472e+02 lambda=4.5897967908360529e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434724062782e+02 lambda=4.5897967908360533e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433965706606e+02 lambda=4.5897967908360533e-08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958168196e+02 lambda=4.5897967908360538e-09 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958098155e+02 lambda=4.5897967908360540e-10 > > > Line search: Cubically determined step, current gnorm 1.433958097906e+02 lambda=1.9745369723997599e-10 > > > 40 SNES Function norm 1.433958097906e+02 > > > 0 KSP Residual norm 8.722495521587e+04 > > > 1 KSP Residual norm 3.742695919275e-09 > > > Line search: gnorm after quadratic fit 6.262538457180e+13 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.829256308992e+12 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.789282877890e+11 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.224340679566e+11 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.532137613500e+10 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.919506047737e+09 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.410488718338e+08 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.042211373104e+07 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.881986305609e+06 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.080857001861e+05 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.054449734307e+04 lambda=9.7656250000000005e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.109051581397e+04 lambda=4.8828125000000003e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.144985497099e+03 lambda=2.4414062500000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.617627947761e+02 lambda=1.2207031250000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.132828960986e+02 lambda=5.3137869181552773e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.440403409760e+02 lambda=5.3137869181552777e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434022226216e+02 lambda=5.3137869181552781e-08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958732177e+02 lambda=5.3137869181552781e-09 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958103569e+02 lambda=5.3137869181552779e-10 > > > Line search: Cubically determined step, current gnorm 1.433958097894e+02 lambda=5.3137869181552781e-11 > > > 41 SNES Function norm 1.433958097894e+02 > > > 0 KSP Residual norm 6.453169081212e+04 > > > 1 KSP Residual norm 2.762540688686e-09 > > > Line search: gnorm after quadratic fit 2.535166112592e+13 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.168366990040e+12 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.958985371462e+11 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.945064622488e+10 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.172244865713e+09 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.693002384290e+08 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.562568994785e+07 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.182957296890e+07 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.453260254263e+06 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.781984147743e+05 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.294934468515e+04 lambda=9.7656250000000005e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.740461720782e+03 lambda=4.8828125000000003e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.162621855154e+02 lambda=2.4414062500000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.042417294890e+02 lambda=1.1290474210136388e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.458920680477e+02 lambda=1.4201366604660443e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434208620254e+02 lambda=1.4201366604660444e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433960586269e+02 lambda=1.4201366604660445e-08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958120934e+02 lambda=1.4201366604660445e-09 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958097940e+02 lambda=1.4201366604660446e-10 > > > Line search: Cubically determined step, current gnorm 1.433958097852e+02 lambda=5.7981795207229486e-11 > > > 42 SNES Function norm 1.433958097852e+02 > > > 0 KSP Residual norm 1.596625793747e+05 > > > 1 KSP Residual norm 6.465899717071e-09 > > > Line search: gnorm after quadratic fit 3.840699863976e+14 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.801237514773e+13 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.002454410823e+12 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.505340831651e+11 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.387378188418e+10 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.174857842415e+10 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.472211181784e+09 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.849608933788e+08 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.336592011613e+07 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.988079805895e+06 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.930858080425e+05 lambda=9.7656250000000005e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.521190722497e+04 lambda=4.8828125000000003e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.872153015323e+03 lambda=2.4414062500000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.772337662956e+03 lambda=1.2207031250000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.879470852054e+02 lambda=6.1035156250000003e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.942774855488e+02 lambda=2.4957912736226801e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.438719078958e+02 lambda=2.4957912736226800e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434005516391e+02 lambda=2.4957912736226800e-08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958568732e+02 lambda=2.4957912736226803e-09 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958102244e+02 lambda=2.4957912736226804e-10 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958097865e+02 lambda=2.4957912736226805e-11 > > > Line search: Cubically determined step, current gnorm 1.433958097846e+02 lambda=9.2900433293108317e-12 > > > 43 SNES Function norm 1.433958097846e+02 > > > 0 KSP Residual norm 4.230869747157e+05 > > > 1 KSP Residual norm 2.238707423027e-08 > > > Line search: gnorm after quadratic fit 7.145700515048e+15 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.931871281700e+14 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.116420341041e+14 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.395366610168e+13 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.743811756566e+12 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.178776103292e+11 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.721012032848e+10 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.395186924428e+09 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.229125978585e+08 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.250971135953e+07 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.483856203094e+06 lambda=9.7656250000000005e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.950671355228e+05 lambda=4.8828125000000003e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.795408218555e+04 lambda=2.4414062500000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.315025696280e+04 lambda=1.2207031250000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.395961070555e+03 lambda=6.1035156250000003e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.565070307576e+02 lambda=3.0517578125000002e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.228949713871e+02 lambda=1.2154989071946628e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.441831998014e+02 lambda=1.2154989071946629e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434037055996e+02 lambda=1.2154989071946630e-08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958886074e+02 lambda=1.2154989071946630e-09 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958105564e+02 lambda=1.2154989071946630e-10 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958097907e+02 lambda=1.2154989071946631e-11 > > > Line search: Cubically determined step, current gnorm 1.433958097845e+02 lambda=1.3559489351735629e-12 > > > 44 SNES Function norm 1.433958097845e+02 > > > 0 KSP Residual norm 1.017589039922e+06 > > > 1 KSP Residual norm 5.483283808994e-08 > > > Line search: gnorm after quadratic fit 9.942386816509e+16 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.242813073279e+16 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.553553149772e+15 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.942033483320e+14 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.427772097758e+13 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.035291372732e+12 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.795558047824e+11 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.748073147307e+10 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.944235240368e+09 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.453550734860e+08 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.377045707707e+07 lambda=9.7656250000000005e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.188119937132e+07 lambda=4.8828125000000003e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.529730353136e+06 lambda=2.4414062500000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.044646611329e+05 lambda=1.2207031250000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.974477616118e+04 lambda=6.1035156250000003e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.087923877078e+03 lambda=3.0517578125000002e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.112257173311e+03 lambda=1.5258789062500001e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.536190077033e+02 lambda=7.6293945312500004e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.622567424729e+02 lambda=2.4244966960965791e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.435780438142e+02 lambda=2.4244966960965793e-08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433976282603e+02 lambda=2.4244966960965796e-09 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958279382e+02 lambda=2.4244966960965797e-10 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958099632e+02 lambda=2.4244966960965799e-11 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958097860e+02 lambda=2.4244966960965801e-12 > > > Line search: Cubically determined step, current gnorm 1.433958097845e+02 lambda=2.4244966960965801e-13 > > > 45 SNES Function norm 1.433958097845e+02 > > > 0 KSP Residual norm 2.206687220910e+06 > > > 1 KSP Residual norm 4.897651438902e-08 > > > Line search: gnorm after quadratic fit 1.013883843512e+18 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.267347883019e+17 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.584167551460e+16 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.980166189110e+15 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.475099638694e+14 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.093604443378e+13 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.866330988164e+12 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.831230804145e+11 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.034848618023e+10 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.533173457427e+09 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.390937545910e+08 lambda=9.7656250000000005e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.167706366282e+08 lambda=4.8828125000000003e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.445357932595e+07 lambda=2.4414062500000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.776833600920e+06 lambda=1.2207031250000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.177171496134e+05 lambda=6.1035156250000003e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.775750596740e+04 lambda=3.0517578125000002e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.374283858049e+03 lambda=1.5258789062500001e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.030949543491e+03 lambda=7.6293945312500004e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.423064811256e+02 lambda=3.6673216108643130e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.499924205417e+02 lambda=6.7541706529544844e-08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434620968378e+02 lambda=6.7541706529544851e-09 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433964732224e+02 lambda=6.7541706529544853e-10 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958164087e+02 lambda=6.7541706529544856e-11 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958098496e+02 lambda=6.7541706529544860e-12 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958097850e+02 lambda=6.7541706529544869e-13 > > > Line search: unable to find good step length! After 24 tries > > > Line search: fnorm=1.4339580978447020e+02, gnorm=1.4339580978501337e+02, ynorm=2.2066872446260620e+06, minlambda=9.9999999999999998e-13, lambda=6.7541706529544869e-13, initial slope=-2.0562359199040133e+04 > > > 0 SNES Function norm 7.494832241120e+03 > > > 0 KSP Residual norm 2.096735360816e+01 > > > 1 KSP Residual norm 1.310027756820e-12 > > > Line search: gnorm after quadratic fit 6.728375857515e+03 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 1 SNES Function norm 6.728375857515e+03 > > > 0 KSP Residual norm 2.051806116405e+01 > > > 1 KSP Residual norm 4.624620138831e-13 > > > Line search: gnorm after quadratic fit 6.028616261650e+03 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 2 SNES Function norm 6.028616261650e+03 > > > 0 KSP Residual norm 2.416503160016e+01 > > > 1 KSP Residual norm 8.456041680630e-13 > > > Line search: gnorm after quadratic fit 5.407473517447e+03 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 3 SNES Function norm 5.407473517447e+03 > > > 0 KSP Residual norm 1.429873750399e+01 > > > 1 KSP Residual norm 2.956316145819e-13 > > > Line search: Using full step: fnorm 5.407473517447e+03 gnorm 1.894530516076e+03 > > > 4 SNES Function norm 1.894530516076e+03 > > > 0 KSP Residual norm 2.898580554597e+00 > > > 1 KSP Residual norm 6.622560162623e-14 > > > Line search: Using full step: fnorm 1.894530516076e+03 gnorm 1.794029421846e+03 > > > 5 SNES Function norm 1.794029421846e+03 > > > 0 KSP Residual norm 1.749678611959e+01 > > > 1 KSP Residual norm 8.138905825078e-12 > > > Line search: gnorm after quadratic fit 1.767361408940e+03 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 6 SNES Function norm 1.767361408940e+03 > > > 0 KSP Residual norm 1.094404109423e+02 > > > 1 KSP Residual norm 7.696691527700e-12 > > > Line search: gnorm after quadratic fit 3.545750923895e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.153479540314e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.205683629874e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.802976525485e+03 lambda=1.2441094586006883e-02 > > > Line search: Cubically determined step, current gnorm 1.765063299263e+03 lambda=4.9240328094708914e-03 > > > 7 SNES Function norm 1.765063299263e+03 > > > 0 KSP Residual norm 1.778095975189e+01 > > > 1 KSP Residual norm 2.814661813934e-12 > > > Line search: gnorm after quadratic fit 2.620761680117e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.793045753271e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.740299227935e+03 lambda=2.5000000000000001e-02 > > > 8 SNES Function norm 1.740299227935e+03 > > > 0 KSP Residual norm 3.284236894535e+02 > > > 1 KSP Residual norm 5.172103783952e-10 > > > Line search: gnorm after quadratic fit 2.857820523902e+05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.063993491139e+04 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.588139591650e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.491163684413e+03 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.802614760566e+03 lambda=5.7977212395253904e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.741444490992e+03 lambda=1.8448315876950813e-03 > > > Line search: Cubically determined step, current gnorm 1.739663656043e+03 lambda=7.7468345598227730e-04 > > > 9 SNES Function norm 1.739663656043e+03 > > > 0 KSP Residual norm 4.581839103558e+02 > > > 1 KSP Residual norm 2.627035885943e-11 > > > Line search: gnorm after quadratic fit 8.199478499066e+05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.127270076812e+05 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.816774161281e+04 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.053723877333e+03 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.971814513392e+03 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.755066208174e+03 lambda=2.7232010924558834e-03 > > > Line search: Cubically determined step, current gnorm 1.739559834479e+03 lambda=8.1458417855297680e-04 > > > 10 SNES Function norm 1.739559834479e+03 > > > 0 KSP Residual norm 1.463056810139e+02 > > > 1 KSP Residual norm 5.383584598825e-12 > > > Line search: gnorm after quadratic fit 2.885699620595e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.847717401708e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.244464170034e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.769157604338e+03 lambda=1.0857209099577540e-02 > > > Line search: Cubically determined step, current gnorm 1.737356225452e+03 lambda=4.0312937622950231e-03 > > > 11 SNES Function norm 1.737356225452e+03 > > > 0 KSP Residual norm 1.564105677925e+02 > > > 1 KSP Residual norm 6.671164745832e-11 > > > Line search: gnorm after quadratic fit 3.815800291873e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.197027796134e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.373151605545e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.783976520867e+03 lambda=1.2093374970461970e-02 > > > Line search: Cubically determined step, current gnorm 1.735737929915e+03 lambda=4.9529698477569920e-03 > > > 12 SNES Function norm 1.735737929915e+03 > > > 0 KSP Residual norm 5.030757139645e+01 > > > 1 KSP Residual norm 1.157542730692e-12 > > > Line search: gnorm after quadratic fit 3.004544441458e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.850403239750e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.722893188305e+03 lambda=2.0881992439921702e-02 > > > 13 SNES Function norm 1.722893188305e+03 > > > 0 KSP Residual norm 7.123428853845e+01 > > > 1 KSP Residual norm 8.671726774894e-12 > > > Line search: gnorm after quadratic fit 4.361041499279e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.032697222107e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.726212330814e+03 lambda=1.9909470348267504e-02 > > > Line search: Cubically determined step, current gnorm 1.714127356920e+03 lambda=9.9547351741337518e-03 > > > 14 SNES Function norm 1.714127356920e+03 > > > 0 KSP Residual norm 8.304557447257e+00 > > > 1 KSP Residual norm 6.268295862688e-13 > > > Line search: gnorm after quadratic fit 1.558163002487e+03 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 15 SNES Function norm 1.558163002487e+03 > > > 0 KSP Residual norm 2.820803287164e+00 > > > 1 KSP Residual norm 5.477413853752e-13 > > > Line search: gnorm after quadratic fit 1.065673478530e+03 > > > Line search: Quadratically determined step, lambda=3.8943438938591052e-01 > > > 16 SNES Function norm 1.065673478530e+03 > > > 0 KSP Residual norm 2.296739120664e+00 > > > 1 KSP Residual norm 6.273731899885e-14 > > > Line search: gnorm after quadratic fit 8.964342150621e+02 > > > Line search: Quadratically determined step, lambda=1.8740736900935545e-01 > > > 17 SNES Function norm 8.964342150621e+02 > > > 0 KSP Residual norm 5.567568505830e+00 > > > 1 KSP Residual norm 8.649083600764e-12 > > > Line search: gnorm after quadratic fit 8.322514858992e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 18 SNES Function norm 8.322514858992e+02 > > > 0 KSP Residual norm 1.164393577210e+00 > > > 1 KSP Residual norm 2.019248309015e-14 > > > Line search: Using full step: fnorm 8.322514858992e+02 gnorm 3.179750274746e+02 > > > 19 SNES Function norm 3.179750274746e+02 > > > 0 KSP Residual norm 5.339294310641e+00 > > > 1 KSP Residual norm 2.070321587238e-13 > > > Line search: gnorm after quadratic fit 3.433012316833e+02 > > > Line search: Cubically determined step, current gnorm 3.140305403821e+02 lambda=5.0000000000000003e-02 > > > 20 SNES Function norm 3.140305403821e+02 > > > 0 KSP Residual norm 1.177016565578e+01 > > > 1 KSP Residual norm 2.413027540446e-13 > > > Line search: gnorm after quadratic fit 7.377851778409e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.896721016582e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 3.136619309181e+02 lambda=9.7219892278716195e-03 > > > 21 SNES Function norm 3.136619309181e+02 > > > 0 KSP Residual norm 3.973565083977e+00 > > > 1 KSP Residual norm 9.726786674410e-14 > > > Line search: gnorm after quadratic fit 3.098277326090e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 22 SNES Function norm 3.098277326090e+02 > > > 0 KSP Residual norm 9.389290683519e+00 > > > 1 KSP Residual norm 1.651497163724e-13 > > > Line search: gnorm after quadratic fit 6.887970540455e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.588146381477e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.099274823603e+02 lambda=1.6890426151283184e-02 > > > Line search: Cubically determined step, current gnorm 3.084890760827e+02 lambda=8.4452130756415920e-03 > > > 23 SNES Function norm 3.084890760827e+02 > > > 0 KSP Residual norm 2.381130479641e+00 > > > 1 KSP Residual norm 4.694489283156e-14 > > > Line search: gnorm after quadratic fit 2.872151876535e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 24 SNES Function norm 2.872151876535e+02 > > > 0 KSP Residual norm 2.405498502269e+00 > > > 1 KSP Residual norm 3.316846070538e-13 > > > Line search: gnorm after quadratic fit 2.686789761232e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 25 SNES Function norm 2.686789761232e+02 > > > 0 KSP Residual norm 1.728772970554e+00 > > > 1 KSP Residual norm 4.132974383339e-14 > > > Line search: gnorm after quadratic fit 2.365009918229e+02 > > > Line search: Quadratically determined step, lambda=1.7273357529379074e-01 > > > 26 SNES Function norm 2.365009918229e+02 > > > 0 KSP Residual norm 4.413764759374e+00 > > > 1 KSP Residual norm 5.210690816917e-14 > > > Line search: gnorm after quadratic fit 2.756730968257e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.372321757171e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 2.335020811250e+02 lambda=2.5000000000000001e-02 > > > 27 SNES Function norm 2.335020811250e+02 > > > 0 KSP Residual norm 1.606246507553e+00 > > > 1 KSP Residual norm 3.564847846678e-14 > > > Line search: gnorm after quadratic fit 2.078263630653e+02 > > > Line search: Quadratically determined step, lambda=1.5913860995949433e-01 > > > 28 SNES Function norm 2.078263630653e+02 > > > 0 KSP Residual norm 3.700632954873e+00 > > > 1 KSP Residual norm 5.113863400264e-13 > > > Line search: gnorm after quadratic fit 2.142503514807e+02 > > > Line search: Cubically determined step, current gnorm 2.021095009118e+02 lambda=5.0000000000000003e-02 > > > 29 SNES Function norm 2.021095009118e+02 > > > 0 KSP Residual norm 3.056449560135e+00 > > > 1 KSP Residual norm 3.207987681334e-14 > > > Line search: gnorm after quadratic fit 2.064252530802e+02 > > > Line search: Cubically determined step, current gnorm 1.978069081639e+02 lambda=5.0000000000000003e-02 > > > 30 SNES Function norm 1.978069081639e+02 > > > 0 KSP Residual norm 2.024695620703e+00 > > > 1 KSP Residual norm 5.460360737995e-14 > > > Line search: gnorm after quadratic fit 1.839556530796e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 31 SNES Function norm 1.839556530796e+02 > > > 0 KSP Residual norm 1.610676619931e+01 > > > 1 KSP Residual norm 6.703552136307e-13 > > > Line search: gnorm after quadratic fit 7.186735314913e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.905672430097e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.856766286600e+02 lambda=1.0830798014298563e-02 > > > Line search: Cubically determined step, current gnorm 1.836818937131e+02 lambda=3.3207362501459785e-03 > > > 32 SNES Function norm 1.836818937131e+02 > > > 0 KSP Residual norm 7.471722173131e+01 > > > 1 KSP Residual norm 2.671534648829e-12 > > > Line search: gnorm after quadratic fit 9.613379909411e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.509491298762e+04 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.808861367705e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.767283758299e+02 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.665421328348e+02 lambda=6.0369453941238101e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.869726717041e+02 lambda=1.4394327006264963e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.836897704575e+02 lambda=1.4394327006264963e-04 > > > Line search: Cubically determined step, current gnorm 1.836767951408e+02 lambda=5.5567420418543164e-05 > > > 33 SNES Function norm 1.836767951408e+02 > > > 0 KSP Residual norm 2.702367712138e+01 > > > 1 KSP Residual norm 2.731656687850e-12 > > > Line search: gnorm after quadratic fit 3.331563146098e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.723694790688e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.941243220944e+02 lambda=2.1443568774664485e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.847231733910e+02 lambda=2.7571330376860012e-03 > > > Line search: Cubically determined step, current gnorm 1.836356729409e+02 lambda=4.7841280418270480e-04 > > > 34 SNES Function norm 1.836356729409e+02 > > > 0 KSP Residual norm 1.228333177997e+01 > > > 1 KSP Residual norm 2.681127387880e-13 > > > Line search: gnorm after quadratic fit 6.936329223475e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.749327218775e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.871557327742e+02 lambda=1.4160505301999991e-02 > > > Line search: Cubically determined step, current gnorm 1.833523080682e+02 lambda=3.5196326548579192e-03 > > > 35 SNES Function norm 1.833523080682e+02 > > > 0 KSP Residual norm 3.531886257396e+02 > > > 1 KSP Residual norm 2.364634092895e-11 > > > Line search: gnorm after quadratic fit 3.994783047929e+06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.753715960726e+05 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.516669898185e+04 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.918985942348e+03 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.363599250418e+03 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.344906818752e+02 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.991088183980e+02 lambda=1.0108094710462592e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.834621681844e+02 lambda=1.0108094710462593e-04 > > > Line search: Cubically determined step, current gnorm 1.833517377324e+02 lambda=1.0108094710462594e-05 > > > 36 SNES Function norm 1.833517377324e+02 > > > 0 KSP Residual norm 9.005833507118e+01 > > > 1 KSP Residual norm 6.116387880629e-12 > > > Line search: gnorm after quadratic fit 8.899847103226e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.388111536526e+04 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.532652074749e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.864912734009e+02 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.421068789960e+02 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.873498120960e+02 lambda=2.1924025345283278e-03 > > > Line search: Cubically determined step, current gnorm 1.833506987706e+02 lambda=2.1924025345283280e-04 > > > 37 SNES Function norm 1.833506987706e+02 > > > 0 KSP Residual norm 1.548426525207e+01 > > > 1 KSP Residual norm 1.038038773942e-12 > > > Line search: gnorm after quadratic fit 6.702848665441e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.789880616078e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.846521504351e+02 lambda=1.0567302644323170e-02 > > > Line search: Cubically determined step, current gnorm 1.830548481815e+02 lambda=3.5274490352771972e-03 > > > 38 SNES Function norm 1.830548481815e+02 > > > 0 KSP Residual norm 1.523095478807e+01 > > > 1 KSP Residual norm 1.963823596119e-12 > > > Line search: gnorm after quadratic fit 9.255727478491e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.496757253461e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.863126241242e+02 lambda=9.3143291632966311e-03 > > > Line search: Cubically determined step, current gnorm 1.829091761403e+02 lambda=1.8107234819462800e-03 > > > 39 SNES Function norm 1.829091761403e+02 > > > 0 KSP Residual norm 1.311320726934e+01 > > > 1 KSP Residual norm 9.084170520902e-13 > > > Line search: gnorm after quadratic fit 7.488610069188e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.691148243365e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.885558228772e+02 lambda=1.9439894235886539e-02 > > > Line search: Cubically determined step, current gnorm 1.825540619134e+02 lambda=5.4967824488704169e-03 > > > 40 SNES Function norm 1.825540619134e+02 > > > 0 KSP Residual norm 1.218635557505e+01 > > > 1 KSP Residual norm 7.760485728617e-13 > > > Line search: gnorm after quadratic fit 6.636453826807e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.880828006022e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.830493790584e+02 lambda=6.6234802648049863e-03 > > > Line search: Cubically determined step, current gnorm 1.823397545268e+02 lambda=2.4308217464828865e-03 > > > 41 SNES Function norm 1.823397545268e+02 > > > 0 KSP Residual norm 9.456543593865e+00 > > > 1 KSP Residual norm 7.046593270309e-13 > > > Line search: gnorm after quadratic fit 3.369769163110e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.105230957789e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.817897533119e+02 lambda=9.1612481372917148e-03 > > > 42 SNES Function norm 1.817897533119e+02 > > > 0 KSP Residual norm 7.290035145805e+00 > > > 1 KSP Residual norm 3.198962158141e-12 > > > Line search: gnorm after quadratic fit 2.858311567415e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.965004842981e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.808845577764e+02 lambda=1.3826421990147811e-02 > > > 43 SNES Function norm 1.808845577764e+02 > > > 0 KSP Residual norm 7.256785036157e+00 > > > 1 KSP Residual norm 9.243179217625e-14 > > > Line search: gnorm after quadratic fit 2.534388176390e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.916726818893e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.797953125543e+02 lambda=1.3677747819164022e-02 > > > 44 SNES Function norm 1.797953125543e+02 > > > 0 KSP Residual norm 1.716201096352e+01 > > > 1 KSP Residual norm 2.701418800808e-13 > > > Line search: gnorm after quadratic fit 1.331064301474e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.461842246267e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.920668830294e+02 lambda=1.2856504859057132e-02 > > > Line search: Cubically determined step, current gnorm 1.797121460957e+02 lambda=1.4396611381500967e-03 > > > 45 SNES Function norm 1.797121460957e+02 > > > 0 KSP Residual norm 6.613432967985e+00 > > > 1 KSP Residual norm 1.357752977076e-13 > > > Line search: gnorm after quadratic fit 2.721288927858e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.939638282615e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.787985482018e+02 lambda=1.2647907914070569e-02 > > > 46 SNES Function norm 1.787985482018e+02 > > > 0 KSP Residual norm 1.225736349281e+01 > > > 1 KSP Residual norm 3.819378790812e-13 > > > Line search: gnorm after quadratic fit 4.548006065036e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.304803559060e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.787344729174e+02 lambda=8.9002284237256531e-03 > > > 47 SNES Function norm 1.787344729174e+02 > > > 0 KSP Residual norm 6.302465402340e+00 > > > 1 KSP Residual norm 6.980931947122e-14 > > > Line search: gnorm after quadratic fit 2.879477700004e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.980806946742e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.780128006935e+02 lambda=1.0223293444602008e-02 > > > 48 SNES Function norm 1.780128006935e+02 > > > 0 KSP Residual norm 4.323829277968e+00 > > > 1 KSP Residual norm 5.223881369308e-13 > > > Line search: gnorm after quadratic fit 1.957928151218e+02 > > > Line search: Cubically determined step, current gnorm 1.768899805640e+02 lambda=5.0000000000000003e-02 > > > 49 SNES Function norm 1.768899805640e+02 > > > 0 KSP Residual norm 2.249256107033e+00 > > > 1 KSP Residual norm 3.624400957270e-14 > > > Line search: gnorm after quadratic fit 1.704782114773e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 50 SNES Function norm 1.704782114773e+02 > > > 0 SNES Function norm 3.513783397332e+03 > > > 0 KSP Residual norm 1.650214950648e+01 > > > 1 KSP Residual norm 3.574269752690e-13 > > > Line search: gnorm after quadratic fit 3.155830404050e+03 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 1 SNES Function norm 3.155830404050e+03 > > > 0 KSP Residual norm 1.443734018042e+01 > > > 1 KSP Residual norm 3.685565191058e-13 > > > Line search: Using full step: fnorm 3.155830404050e+03 gnorm 8.581212204155e+02 > > > 2 SNES Function norm 8.581212204155e+02 > > > 0 KSP Residual norm 2.492601775565e+00 > > > 1 KSP Residual norm 9.698440210389e-14 > > > Line search: Using full step: fnorm 8.581212204155e+02 gnorm 7.018609898542e+02 > > > 3 SNES Function norm 7.018609898542e+02 > > > 0 KSP Residual norm 1.740320986421e+00 > > > 1 KSP Residual norm 2.868780682435e-14 > > > Line search: Using full step: fnorm 7.018609898542e+02 gnorm 2.135824235887e+02 > > > 4 SNES Function norm 2.135824235887e+02 > > > 0 KSP Residual norm 1.647413497077e+00 > > > 1 KSP Residual norm 2.731226225666e-14 > > > Line search: gnorm after quadratic fit 1.936469032649e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 5 SNES Function norm 1.936469032649e+02 > > > 0 KSP Residual norm 1.406615972124e+00 > > > 1 KSP Residual norm 3.167179626699e-14 > > > Line search: gnorm after quadratic fit 1.755362571467e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 6 SNES Function norm 1.755362571467e+02 > > > 0 KSP Residual norm 1.480681706594e+00 > > > 1 KSP Residual norm 2.935210968935e-14 > > > Line search: gnorm after quadratic fit 1.597659506616e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 7 SNES Function norm 1.597659506616e+02 > > > 0 KSP Residual norm 4.013154698097e+00 > > > 1 KSP Residual norm 1.021628704832e-13 > > > Line search: gnorm after quadratic fit 1.728408060966e+02 > > > Line search: Cubically determined step, current gnorm 1.570815760721e+02 lambda=5.0000000000000003e-02 > > > 8 SNES Function norm 1.570815760721e+02 > > > 0 KSP Residual norm 1.510335662636e+00 > > > 1 KSP Residual norm 2.728243244724e-14 > > > Line search: gnorm after quadratic fit 1.450162880692e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 9 SNES Function norm 1.450162880692e+02 > > > 0 KSP Residual norm 1.923349271077e+01 > > > 1 KSP Residual norm 1.640711956406e-11 > > > Line search: gnorm after quadratic fit 1.016537223115e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.584263092048e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.490729346583e+02 lambda=9.3725990358703350e-03 > > > Line search: Cubically determined step, current gnorm 1.449349273006e+02 lambda=1.5464889706033082e-03 > > > 10 SNES Function norm 1.449349273006e+02 > > > 0 KSP Residual norm 1.154999084194e+01 > > > 1 KSP Residual norm 1.292167633338e-11 > > > Line search: gnorm after quadratic fit 6.060386918705e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.236630526035e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.491201927819e+02 lambda=1.6816056300124185e-02 > > > Line search: Cubically determined step, current gnorm 1.447023047013e+02 lambda=4.1484374564153808e-03 > > > 11 SNES Function norm 1.447023047013e+02 > > > 0 KSP Residual norm 7.278906180502e+00 > > > 1 KSP Residual norm 2.815632651924e-12 > > > Line search: gnorm after quadratic fit 2.512278711773e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.624350957814e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.441656049510e+02 lambda=1.0879389002513012e-02 > > > 12 SNES Function norm 1.441656049510e+02 > > > 0 KSP Residual norm 4.449836480267e+00 > > > 1 KSP Residual norm 3.152365624813e-13 > > > Line search: gnorm after quadratic fit 1.749680739878e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.458763435996e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.425715025152e+02 lambda=2.2766809271842225e-02 > > > 13 SNES Function norm 1.425715025152e+02 > > > 0 KSP Residual norm 4.218495037726e+00 > > > 1 KSP Residual norm 1.398472536142e-12 > > > Line search: gnorm after quadratic fit 1.645159536467e+02 > > > Line search: Cubically determined step, current gnorm 1.421991559212e+02 lambda=4.1883769431247941e-02 > > > 14 SNES Function norm 1.421991559212e+02 > > > 0 KSP Residual norm 1.968853538608e+00 > > > 1 KSP Residual norm 7.594023450519e-12 > > > Line search: gnorm after quadratic fit 1.350960142124e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 15 SNES Function norm 1.350960142124e+02 > > > 0 KSP Residual norm 3.444721686085e+00 > > > 1 KSP Residual norm 5.312609674019e-14 > > > Line search: gnorm after quadratic fit 1.472880565107e+02 > > > Line search: Cubically determined step, current gnorm 1.336714620145e+02 lambda=4.1341550820829437e-02 > > > 16 SNES Function norm 1.336714620145e+02 > > > 0 KSP Residual norm 3.276288899397e+00 > > > 1 KSP Residual norm 8.394674946715e-14 > > > Line search: gnorm after quadratic fit 1.459274497150e+02 > > > Line search: Cubically determined step, current gnorm 1.327618539486e+02 lambda=5.0000000000000003e-02 > > > 17 SNES Function norm 1.327618539486e+02 > > > 0 KSP Residual norm 2.630052244303e+00 > > > 1 KSP Residual norm 4.351283410507e-14 > > > Line search: gnorm after quadratic fit 1.350378060116e+02 > > > Line search: Cubically determined step, current gnorm 1.299403903934e+02 lambda=4.9913529436269283e-02 > > > 18 SNES Function norm 1.299403903934e+02 > > > 0 KSP Residual norm 6.124953430138e+00 > > > 1 KSP Residual norm 2.295381352938e-13 > > > Line search: gnorm after quadratic fit 2.275621676963e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.469611730657e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.294890694898e+02 lambda=1.0071939100661648e-02 > > > 19 SNES Function norm 1.294890694898e+02 > > > 0 KSP Residual norm 1.036733907011e+01 > > > 1 KSP Residual norm 1.800941381283e-13 > > > Line search: gnorm after quadratic fit 3.844879463595e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.875071148504e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.294494430642e+02 lambda=5.0000000000000010e-03 > > > 20 SNES Function norm 1.294494430642e+02 > > > 0 KSP Residual norm 8.224001595443e+00 > > > 1 KSP Residual norm 3.337810156182e-13 > > > Line search: gnorm after quadratic fit 3.332325263497e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.682441841234e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.294720538860e+02 lambda=8.5401597581228530e-03 > > > Line search: Cubically determined step, current gnorm 1.291762382985e+02 lambda=4.2555418164960989e-03 > > > 21 SNES Function norm 1.291762382985e+02 > > > 0 KSP Residual norm 3.920749219860e+01 > > > 1 KSP Residual norm 1.610902886435e-12 > > > Line search: gnorm after quadratic fit 3.472422440640e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.023065712859e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.228184088700e+02 lambda=1.6004598823093592e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.298607525058e+02 lambda=1.6004598823093593e-03 > > > Line search: Cubically determined step, current gnorm 1.291643460998e+02 lambda=1.9319076533745672e-04 > > > 22 SNES Function norm 1.291643460998e+02 > > > 0 KSP Residual norm 1.520092314848e+02 > > > 1 KSP Residual norm 7.089159192434e-11 > > > Line search: gnorm after quadratic fit 2.752539686422e+05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.237188995536e+04 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.484370498858e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.571039994484e+03 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.280898858362e+02 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.708927009106e+02 lambda=2.6114913411793973e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.294919567784e+02 lambda=2.6114913411793975e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291645609810e+02 lambda=2.6114913411793977e-05 > > > Line search: Cubically determined step, current gnorm 1.291635530596e+02 lambda=1.2278773895355162e-05 > > > 23 SNES Function norm 1.291635530596e+02 > > > 0 KSP Residual norm 7.569206058965e+02 > > > 1 KSP Residual norm 3.454693729751e-11 > > > Line search: gnorm after quadratic fit 2.570888738395e+07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.064965025187e+06 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.498514098182e+05 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.807487005202e+04 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.233167830543e+03 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.396736912757e+03 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.547572543330e+02 lambda=1.2623406091699435e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.335889024473e+02 lambda=1.8542137907683829e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.292059042479e+02 lambda=1.8542137907683831e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291637618568e+02 lambda=1.8542137907683832e-06 > > > Line search: Cubically determined step, current gnorm 1.291635210734e+02 lambda=4.9524172913414387e-07 > > > 24 SNES Function norm 1.291635210734e+02 > > > 0 KSP Residual norm 3.761913422861e+03 > > > 1 KSP Residual norm 6.181718776929e-10 > > > Line search: gnorm after quadratic fit 3.342370445037e+09 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.218326646111e+08 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.375128803204e+07 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.980626157021e+06 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.407418671219e+05 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.357321025399e+05 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.188948059047e+04 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.105117929713e+03 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.331054736818e+02 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.942479792843e+02 lambda=1.9412500272460620e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.436944624694e+02 lambda=6.4483223307578726e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.292972287211e+02 lambda=6.4483223307578726e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291647778160e+02 lambda=6.4483223307578730e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635261433e+02 lambda=6.4483223307578730e-08 > > > Line search: Cubically determined step, current gnorm 1.291635197798e+02 lambda=2.0042115918485846e-08 > > > 25 SNES Function norm 1.291635197798e+02 > > > 0 KSP Residual norm 1.874745766083e+04 > > > 1 KSP Residual norm 1.476978150334e-09 > > > Line search: gnorm after quadratic fit 4.089262111368e+11 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.101717203770e+10 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.352565940292e+09 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.879613196620e+08 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.698613558125e+07 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.175566265039e+07 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.382919964952e+06 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.545431975334e+05 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.713561369103e+04 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.031789308419e+03 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.205847020738e+02 lambda=9.7656250000000005e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.957203153158e+02 lambda=2.8132879163728503e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.297923302791e+02 lambda=2.8132879163728504e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291698100579e+02 lambda=2.8132879163728504e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635794525e+02 lambda=2.8132879163728506e-08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635200489e+02 lambda=2.8132879163728508e-09 > > > Line search: Cubically determined step, current gnorm 1.291635197275e+02 lambda=8.0832061492461345e-10 > > > 26 SNES Function norm 1.291635197275e+02 > > > 0 KSP Residual norm 9.248381077528e+04 > > > 1 KSP Residual norm 7.262307068447e-09 > > > Line search: gnorm after quadratic fit 4.920647210624e+13 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.153216818065e+12 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.697543960375e+11 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.637004379805e+10 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.208402653149e+10 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.519988135798e+09 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.923903214787e+08 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.465663001976e+07 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.238603967195e+06 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.459179143177e+05 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.676301042792e+04 lambda=9.7656250000000005e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.135808875752e+04 lambda=4.8828125000000003e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.275714918657e+03 lambda=2.4414062500000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.719037747616e+02 lambda=1.2207031250000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.039826156716e+02 lambda=5.5609199181402721e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.308092967809e+02 lambda=9.1057337296683134e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291796742824e+02 lambda=9.1057337296683134e-08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291636800174e+02 lambda=9.1057337296683134e-09 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635212255e+02 lambda=9.1057337296683134e-10 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635197320e+02 lambda=9.1057337296683139e-11 > > > Line search: Cubically determined step, current gnorm 1.291635197254e+02 lambda=3.2898162617097329e-11 > > > 27 SNES Function norm 1.291635197254e+02 > > > 0 KSP Residual norm 4.818745996826e+05 > > > 1 KSP Residual norm 3.300979345194e-08 > > > Line search: gnorm after quadratic fit 6.957046028867e+15 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.695654311477e+14 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.086793500688e+14 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.358083744813e+13 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.696584801696e+12 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.118183549773e+11 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.641372080976e+10 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.285878535769e+09 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.068045470276e+08 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.988290932539e+07 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.001404304764e+06 lambda=9.7656250000000005e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.962234585736e+05 lambda=4.8828125000000003e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.648190078115e+04 lambda=2.4414062500000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.098288624714e+03 lambda=1.2207031250000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.025132922751e+03 lambda=6.1035156250000003e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.536770142392e+02 lambda=3.0517578125000002e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.529553964021e+02 lambda=6.6615844706846272e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.293970371303e+02 lambda=6.6615844706846277e-08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291658631829e+02 lambda=6.6615844706846284e-09 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635430890e+02 lambda=6.6615844706846284e-10 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635199508e+02 lambda=6.6615844706846284e-11 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635197268e+02 lambda=6.6615844706846284e-12 > > > Line search: Cubically determined step, current gnorm 1.291635197253e+02 lambda=1.2496728806533799e-12 > > > 28 SNES Function norm 1.291635197253e+02 > > > 0 KSP Residual norm 2.124622394867e+06 > > > 1 KSP Residual norm 2.766225333896e-07 > > > Line search: gnorm after quadratic fit 5.963587884154e+17 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.454611858824e+16 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.318582340500e+15 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.164902175749e+15 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.456326197371e+14 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.820904039469e+13 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.277371273495e+12 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.849819609184e+11 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.570050545145e+10 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.482064028328e+09 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.651631635063e+08 lambda=9.7656250000000005e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.188623828904e+07 lambda=4.8828125000000003e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.302868645305e+06 lambda=2.4414062500000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.245214424313e+06 lambda=1.2207031250000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.775004618570e+05 lambda=6.1035156250000003e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.810228834086e+04 lambda=3.0517578125000002e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.148910945566e+03 lambda=1.5258789062500001e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.133679879416e+03 lambda=7.6293945312500004e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.382468615011e+02 lambda=3.8146972656250002e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.519773483633e+02 lambda=1.4103864371136453e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.293690599792e+02 lambda=1.4103864371136454e-08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291655645282e+02 lambda=1.4103864371136455e-09 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635401518e+02 lambda=1.4103864371136456e-10 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635199283e+02 lambda=1.4103864371136456e-11 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635197272e+02 lambda=1.4103864371136456e-12 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635197253e+02 lambda=1.4103864371136457e-13 > > > Line search: unable to find good step length! After 25 tries > > > Line search: fnorm=1.2916351972528861e+02, gnorm=1.2916351972529532e+02, ynorm=2.1246218291095798e+06, minlambda=9.9999999999999998e-13, lambda=1.4103864371136457e-13, initial slope=-1.6683210999382733e+04 > > > 0 SNES Function norm 7.158176401507e+03 > > > 0 KSP Residual norm 7.545626598553e+02 > > > 1 KSP Residual norm 2.192822940623e-11 > > > Line search: gnorm after quadratic fit 6.003975664723e+07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.501930637484e+06 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.380142516806e+05 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.179837352860e+05 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.656902039419e+04 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.340091686120e+03 lambda=3.1250000000000002e-03 > > > Line search: Cubically determined step, current gnorm 7.127478647243e+03 lambda=1.5625000000000001e-03 > > > 1 SNES Function norm 7.127478647243e+03 > > > 0 KSP Residual norm 3.139792512249e+01 > > > 1 KSP Residual norm 5.765552480238e-13 > > > Line search: gnorm after quadratic fit 7.131728282938e+03 > > > Line search: Cubically determined step, current gnorm 6.730387269330e+03 lambda=5.0000000000000003e-02 > > > 2 SNES Function norm 6.730387269330e+03 > > > 0 KSP Residual norm 2.247436817553e+01 > > > 1 KSP Residual norm 4.129717651221e-13 > > > Line search: gnorm after quadratic fit 6.018304311910e+03 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 3 SNES Function norm 6.018304311910e+03 > > > 0 KSP Residual norm 1.605973421081e+01 > > > 1 KSP Residual norm 3.614891198134e-13 > > > Line search: gnorm after quadratic fit 5.394599276028e+03 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 4 SNES Function norm 5.394599276028e+03 > > > 0 KSP Residual norm 1.491002227850e+01 > > > 1 KSP Residual norm 5.905756964447e-13 > > > Line search: gnorm after quadratic fit 4.845108544722e+03 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 5 SNES Function norm 4.845108544722e+03 > > > 0 KSP Residual norm 1.562997766581e+02 > > > 1 KSP Residual norm 5.722461855805e-12 > > > Line search: gnorm after quadratic fit 1.663505509947e+05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.368547472010e+04 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.067825049920e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.852173464442e+03 lambda=1.2500000000000001e-02 > > > Line search: Cubically determined step, current gnorm 4.819549937425e+03 lambda=6.2500000000000003e-03 > > > 6 SNES Function norm 4.819549937425e+03 > > > 0 KSP Residual norm 1.652787385042e+01 > > > 1 KSP Residual norm 7.774483442550e-13 > > > Line search: gnorm after quadratic fit 2.868840270198e+03 > > > Line search: Quadratically determined step, lambda=3.9586658383856743e-01 > > > 7 SNES Function norm 2.868840270198e+03 > > > 0 KSP Residual norm 1.220061851091e+01 > > > 1 KSP Residual norm 4.785407437718e-13 > > > Line search: gnorm after quadratic fit 2.616720732407e+03 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 8 SNES Function norm 2.616720732407e+03 > > > 0 KSP Residual norm 2.884722153958e+01 > > > 1 KSP Residual norm 5.474553921306e-13 > > > Line search: gnorm after quadratic fit 3.025386805317e+03 > > > Line search: Cubically determined step, current gnorm 2.572110173067e+03 lambda=5.0000000000000003e-02 > > > 9 SNES Function norm 2.572110173067e+03 > > > 0 KSP Residual norm 5.239447686736e+01 > > > 1 KSP Residual norm 1.006906008399e-12 > > > Line search: gnorm after quadratic fit 5.237562098046e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.722529781980e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 2.553072891461e+03 lambda=2.5000000000000001e-02 > > > 10 SNES Function norm 2.553072891461e+03 > > > 0 KSP Residual norm 6.511316788880e+00 > > > 1 KSP Residual norm 1.340296659008e-13 > > > Line search: gnorm after quadratic fit 2.299704119080e+03 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 11 SNES Function norm 2.299704119080e+03 > > > 0 KSP Residual norm 5.268131426587e+00 > > > 1 KSP Residual norm 1.017563310127e-13 > > > Line search: Using full step: fnorm 2.299704119080e+03 gnorm 7.642690039388e+02 > > > 12 SNES Function norm 7.642690039388e+02 > > > 0 KSP Residual norm 1.467735721574e+01 > > > 1 KSP Residual norm 1.090242963543e-12 > > > Line search: gnorm after quadratic fit 1.042766084830e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.924803860137e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 7.581126971182e+02 lambda=1.8508848315139208e-02 > > > 13 SNES Function norm 7.581126971182e+02 > > > 0 KSP Residual norm 2.222609581896e+00 > > > 1 KSP Residual norm 5.661437314341e-14 > > > Line search: gnorm after quadratic fit 6.235337602260e+02 > > > Line search: Quadratically determined step, lambda=2.1172883827013136e-01 > > > 14 SNES Function norm 6.235337602260e+02 > > > 0 KSP Residual norm 3.080209609798e+00 > > > 1 KSP Residual norm 6.073476899313e-14 > > > Line search: gnorm after quadratic fit 5.704745248520e+02 > > > Line search: Quadratically determined step, lambda=1.0142301129466913e-01 > > > 15 SNES Function norm 5.704745248520e+02 > > > 0 KSP Residual norm 5.628316803979e+00 > > > 1 KSP Residual norm 9.930477041779e-14 > > > Line search: gnorm after quadratic fit 5.401354794776e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 16 SNES Function norm 5.401354794776e+02 > > > 0 KSP Residual norm 2.052541406719e+01 > > > 1 KSP Residual norm 4.328836834239e-13 > > > Line search: gnorm after quadratic fit 1.709850100987e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.717966555703e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.414032576976e+02 lambda=8.7805694170804971e-03 > > > Line search: Cubically determined step, current gnorm 5.391967144330e+02 lambda=3.6341472475199424e-03 > > > 17 SNES Function norm 5.391967144330e+02 > > > 0 KSP Residual norm 2.246993769488e+00 > > > 1 KSP Residual norm 5.078373642913e-14 > > > Line search: gnorm after quadratic fit 4.939618639951e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 18 SNES Function norm 4.939618639951e+02 > > > 0 KSP Residual norm 2.155867648564e+00 > > > 1 KSP Residual norm 4.438622106380e-14 > > > Line search: gnorm after quadratic fit 4.334377322188e+02 > > > Line search: Quadratically determined step, lambda=1.5092486954829210e-01 > > > 19 SNES Function norm 4.334377322188e+02 > > > 0 KSP Residual norm 8.318284791610e+00 > > > 1 KSP Residual norm 6.910116607023e-13 > > > Line search: gnorm after quadratic fit 6.148799641401e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.502386288041e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 4.297879862602e+02 lambda=1.9565738732695813e-02 > > > 20 SNES Function norm 4.297879862602e+02 > > > 0 KSP Residual norm 7.593855254976e+01 > > > 1 KSP Residual norm 1.300639045149e-12 > > > Line search: gnorm after quadratic fit 7.318016560287e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.832525429452e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.543595712952e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.752901058720e+02 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.309726315570e+02 lambda=1.2500000000000002e-03 > > > Line search: Cubically determined step, current gnorm 4.297464967378e+02 lambda=2.0986409143217158e-04 > > > 21 SNES Function norm 4.297464967378e+02 > > > 0 KSP Residual norm 8.492609701850e+00 > > > 1 KSP Residual norm 2.830329105288e-13 > > > Line search: gnorm after quadratic fit 6.575200413213e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.532760802544e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 4.268212296998e+02 lambda=1.8460064973695799e-02 > > > 22 SNES Function norm 4.268212296998e+02 > > > 0 KSP Residual norm 2.527155905469e+00 > > > 1 KSP Residual norm 2.235724978394e-13 > > > Line search: gnorm after quadratic fit 3.958132075117e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 23 SNES Function norm 3.958132075117e+02 > > > 0 KSP Residual norm 3.425644398425e+00 > > > 1 KSP Residual norm 7.166017790799e-14 > > > Line search: gnorm after quadratic fit 3.803199338641e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 24 SNES Function norm 3.803199338641e+02 > > > 0 KSP Residual norm 3.581435186688e+00 > > > 1 KSP Residual norm 1.730091027109e-13 > > > Line search: gnorm after quadratic fit 3.678433353709e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 25 SNES Function norm 3.678433353709e+02 > > > 0 KSP Residual norm 2.817439291614e+00 > > > 1 KSP Residual norm 8.592333136485e-13 > > > Line search: gnorm after quadratic fit 3.472671313564e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 26 SNES Function norm 3.472671313564e+02 > > > 0 KSP Residual norm 1.830066839089e+00 > > > 1 KSP Residual norm 3.248934231575e-14 > > > Line search: gnorm after quadratic fit 3.195079998571e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 27 SNES Function norm 3.195079998571e+02 > > > 0 KSP Residual norm 3.775823654589e+00 > > > 1 KSP Residual norm 1.316233059492e-13 > > > Line search: gnorm after quadratic fit 3.252874639934e+02 > > > Line search: Cubically determined step, current gnorm 3.125168318399e+02 lambda=5.0000000000000003e-02 > > > 28 SNES Function norm 3.125168318399e+02 > > > 0 KSP Residual norm 3.892613775622e+00 > > > 1 KSP Residual norm 7.093200713216e-11 > > > Line search: gnorm after quadratic fit 3.137590389484e+02 > > > Line search: Cubically determined step, current gnorm 3.045559021319e+02 lambda=5.0000000000000003e-02 > > > 29 SNES Function norm 3.045559021319e+02 > > > 0 KSP Residual norm 2.364531179390e+00 > > > 1 KSP Residual norm 1.615423543115e-12 > > > Line search: gnorm after quadratic fit 2.864449141431e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 30 SNES Function norm 2.864449141431e+02 > > > 0 KSP Residual norm 5.187063704081e+00 > > > 1 KSP Residual norm 4.254799504045e-13 > > > Line search: gnorm after quadratic fit 3.171238299438e+02 > > > Line search: Cubically determined step, current gnorm 2.859321807369e+02 lambda=4.9550691080557742e-02 > > > 31 SNES Function norm 2.859321807369e+02 > > > 0 KSP Residual norm 2.400449127985e+01 > > > 1 KSP Residual norm 5.221032480453e-13 > > > Line search: gnorm after quadratic fit 1.812538817802e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.647888939229e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.905120335847e+02 lambda=7.3371687404129469e-03 > > > Line search: Cubically determined step, current gnorm 2.857698450683e+02 lambda=1.3231746793531958e-03 > > > 32 SNES Function norm 2.857698450683e+02 > > > 0 KSP Residual norm 7.438521293559e+00 > > > 1 KSP Residual norm 1.293652874831e-12 > > > Line search: gnorm after quadratic fit 3.600694148787e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.932936811991e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 2.832774969882e+02 lambda=1.8636088141277370e-02 > > > 33 SNES Function norm 2.832774969882e+02 > > > 0 KSP Residual norm 2.676138557891e+00 > > > 1 KSP Residual norm 5.204105674042e-12 > > > Line search: gnorm after quadratic fit 2.698470565576e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 34 SNES Function norm 2.698470565576e+02 > > > 0 KSP Residual norm 1.009562156863e+01 > > > 1 KSP Residual norm 3.544140587695e-13 > > > Line search: gnorm after quadratic fit 5.672695948559e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.197216154647e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 2.694068135292e+02 lambda=1.0762403784106927e-02 > > > 35 SNES Function norm 2.694068135292e+02 > > > 0 KSP Residual norm 3.927549314525e+00 > > > 1 KSP Residual norm 2.619134786598e-13 > > > Line search: gnorm after quadratic fit 2.646675787349e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 36 SNES Function norm 2.646675787349e+02 > > > 0 KSP Residual norm 3.630219417922e+01 > > > 1 KSP Residual norm 1.546302717349e-12 > > > Line search: gnorm after quadratic fit 1.827432666108e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.342968941151e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.008633273369e+02 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.490753494196e+02 lambda=1.2345129233072847e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.682474011960e+02 lambda=3.3291959087019770e-03 > > > Line search: Cubically determined step, current gnorm 2.646227701989e+02 lambda=4.0529212866107715e-04 > > > 37 SNES Function norm 2.646227701989e+02 > > > 0 KSP Residual norm 8.122774697994e+00 > > > 1 KSP Residual norm 1.316362046092e-13 > > > Line search: gnorm after quadratic fit 4.731092571363e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.030088374328e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 2.637462652877e+02 lambda=9.1057248517509397e-03 > > > 38 SNES Function norm 2.637462652877e+02 > > > 0 KSP Residual norm 2.601520363063e+00 > > > 1 KSP Residual norm 1.060764270007e-12 > > > Line search: gnorm after quadratic fit 2.536856446094e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 39 SNES Function norm 2.536856446094e+02 > > > 0 KSP Residual norm 5.447955134327e+01 > > > 1 KSP Residual norm 2.556989975730e-12 > > > Line search: gnorm after quadratic fit 9.199250935618e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.998238940105e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.227083769291e+02 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.852215674478e+02 lambda=8.5024965111563117e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.537821339347e+02 lambda=8.5024965111563122e-04 > > > Line search: Cubically determined step, current gnorm 2.536484146652e+02 lambda=2.9594242443314720e-04 > > > 40 SNES Function norm 2.536484146652e+02 > > > 0 KSP Residual norm 3.357359266965e+01 > > > 1 KSP Residual norm 8.485166742752e-11 > > > Line search: gnorm after quadratic fit 3.327150899857e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.660943990394e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.428891921377e+02 lambda=2.2262238648584176e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.550059920785e+02 lambda=3.9120439672600755e-03 > > > Line search: Cubically determined step, current gnorm 2.535425543202e+02 lambda=8.8078244093807846e-04 > > > 41 SNES Function norm 2.535425543202e+02 > > > 0 KSP Residual norm 1.982789391732e+01 > > > 1 KSP Residual norm 1.156473750758e-11 > > > Line search: gnorm after quadratic fit 9.648483369708e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.023504841042e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.554919970151e+02 lambda=8.7092873850291869e-03 > > > Line search: Cubically determined step, current gnorm 2.532490636747e+02 lambda=2.4564558988847251e-03 > > > 42 SNES Function norm 2.532490636747e+02 > > > 0 KSP Residual norm 1.762994613361e+01 > > > 1 KSP Residual norm 4.550684860593e-12 > > > Line search: gnorm after quadratic fit 6.772107527838e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.370541870778e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.532869639177e+02 lambda=7.7662700854918328e-03 > > > Line search: Cubically determined step, current gnorm 2.527651129995e+02 lambda=3.8686733161537824e-03 > > > 43 SNES Function norm 2.527651129995e+02 > > > 0 KSP Residual norm 1.559278923951e+01 > > > 1 KSP Residual norm 1.060470887103e-11 > > > Line search: gnorm after quadratic fit 7.344361373020e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.498001534426e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.530518382567e+02 lambda=7.6730113050967469e-03 > > > Line search: Cubically determined step, current gnorm 2.523423548732e+02 lambda=3.4156098513217236e-03 > > > 44 SNES Function norm 2.523423548732e+02 > > > 0 KSP Residual norm 1.190500639095e+01 > > > 1 KSP Residual norm 6.311739265577e-12 > > > Line search: gnorm after quadratic fit 4.875196633557e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.933215922947e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 2.516782376717e+02 lambda=9.8878729665301743e-03 > > > 45 SNES Function norm 2.516782376717e+02 > > > 0 KSP Residual norm 1.003632001309e+01 > > > 1 KSP Residual norm 7.039473047666e-13 > > > Line search: gnorm after quadratic fit 3.417133560813e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.636443273929e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 2.499729768042e+02 lambda=1.5332495922160540e-02 > > > 46 SNES Function norm 2.499729768042e+02 > > > 0 KSP Residual norm 5.252587112411e+01 > > > 1 KSP Residual norm 2.072629114336e-12 > > > Line search: gnorm after quadratic fit 7.891803681498e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.819076698717e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.911876424956e+02 lambda=2.4538865368827514e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.688195882303e+02 lambda=6.5764457912135515e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.500076295129e+02 lambda=6.5764457912135523e-04 > > > Line search: Cubically determined step, current gnorm 2.499390700783e+02 lambda=2.7231956365922875e-04 > > > 47 SNES Function norm 2.499390700783e+02 > > > 0 KSP Residual norm 4.007648116930e+01 > > > 1 KSP Residual norm 5.646654234336e-11 > > > Line search: gnorm after quadratic fit 6.276152857499e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.418274035925e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.785345842563e+02 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.665412152699e+02 lambda=8.0607289886479045e-03 > > > Line search: Cubically determined step, current gnorm 2.499109739904e+02 lambda=8.0607289886479045e-04 > > > 48 SNES Function norm 2.499109739904e+02 > > > 0 KSP Residual norm 1.339756751889e+01 > > > 1 KSP Residual norm 2.559175980945e-13 > > > Line search: gnorm after quadratic fit 6.052259901869e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.217431518450e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 2.496541765916e+02 lambda=7.0239599632283649e-03 > > > 49 SNES Function norm 2.496541765916e+02 > > > 0 KSP Residual norm 5.340771873687e+00 > > > 1 KSP Residual norm 1.207454778077e-13 > > > Line search: gnorm after quadratic fit 2.760767095070e+02 > > > Line search: Cubically determined step, current gnorm 2.491630276458e+02 lambda=5.0000000000000003e-02 > > > 50 SNES Function norm 2.491630276458e+02 > > > > > > > > > On Sat, Aug 26, 2017 at 11:45 PM, Barry Smith wrote: > > > > > > > On Aug 26, 2017, at 10:43 PM, zakaryah . wrote: > > > > > > > > Hi Barry - many thanks for taking the time to understand my many problems and providing so much help. > > > > > > > > The reason I was concerned that I could not alter the linesearch was when I tried to use bt instead of the L-BFGS default, cp, the code crashed with an error like "Could not get Jacobian". Maybe this is an incompatibility like you say, since L-BFGS only uses the initial Jacobian and I never tried setting the scale type. > > > > > > > > I took your advice and tried to shrink the problem. First I tried shrinking by a factor 1000 but this converged very quickly with all test data I could provide, including the data which was problematic with the large grid. So I settled for a reduction in size by a factor 125. The grid size is 13,230. This is a decent test case because the solver fails to converge with the options I was using before, and it is small enough that I can run it with the options you suggested (-snes_fd_color -snes_type newtonls -snes_monitor -snes_linesearch_monitor -ksp_monitor -pc_type lu). > > > > > > > > The output is 1800 lines long - how shall I share it? > > > > > > Just email it, that is small enough for email. > > > > > > Barry > > > > > > > > > > > > > > > > > > > > > > > On Sat, Aug 26, 2017 at 7:38 PM, Barry Smith wrote: > > > > > > > > > On Aug 26, 2017, at 5:56 PM, zakaryah . wrote: > > > > > > > > > > I'm using PETSc's SNES methods to solve PDEs which result from Euler-Lagrange equations for the strain energy of a 3D displacement field. There is an additional term in the Lagrangian which describes external forces which arise from various data sets, and that term contains nonlinearities (field terms higher than linear). The grid has about 1.6e6 elements, and the displacement field has 3 components at each grid element. > > > > > > > > > > I'm trying to solve a sequence of successively more complicated equations, and the latest equation is failing to converge on some data sets. In particular, the methods were successful for the infinitesimal bulk strain (compression) energy, as well as the full infinitesimal strain energy (bulk + shear), but I'm now trying to generalize to the finite strain, as certain data sets are known to result from displacement fields for which the infinitesimal strain is a poor approximation. > > > > > > > > > > I'm using a DMDA, closely following example 48, and my preferred solver is L-BFGS. > > > > > > > > So you are using ? > > > > > > > > -snes_type qn -snes_qn_type lbfgs > > > > > > > > > > > > > > I have read the FAQs "Why is Newton's method not converging??" and "Why is my iterative linear solver not converging??"? which have raised a number of questions: > > > > > > > > Quasi Newton methods either don't use Jacobians or use only the initial Jacobian (the idea behind quasi-Newton methods is to approximate Jacobian information from previous iterations without having the user compute a Jacobian at each iteration). With PETSc's qn it only uses the Jacobian if you use the option > > > > > > > > -snes_qn_scale_type Jacobian > > > > > > > > otherwise the Jacobian is never computed or used > > > > > > > > > > > > > > > > > > Is there documentation for the DMDA/SNES methods somewhere? I don't understand these very well. For example, I am not allocating any matrix for the global Jacobian, and I believe this prevents me from changing the line search. If I'm mistaken I would love to see an example of changing the line search type while using DMDA/SNES. > > > > > > > > Whether you provide a Jacobian or not is orthogonal to the line search. > > > > > > > > You should be able to change the line search with > > > > > > > > -snes_linesearch_type bt or nleqerr or basic or l2 or cp > > > > > > > > not all of them may work with qn > > > > > > > > > > > > > > > > > > I don't know how to interpret the linesearch monitor. Even for problems which are converging properly, the linesearch monitor reports "lssucceed=0" on every iteration. Is this a problem? > > > > > > > > It returns a 0 if the line search does not believe it has achieved "sufficient decrease" in the function norm (or possibly some other measure of decrease) you should run -snes_linesearch_monitor also with the option -snes_monitor to see what is happening to the function norm > > > > > > > > For qn you can add the option > > > > > > > > -snes_qn_monitor > > > > > > > > to get more detailed monitoring > > > > > > > > > > > > > > > > > > I'm also having trouble understanding the methods for troubleshooting. I suspect that I've made an error in the analytical Jacobian, which has a rather large number of non-zero elements, but I have no idea how to use -snes_type test -snes_test_display. The FAQs mention that some troubleshooting tools are more useful for small test problems. How small is small? > > > > > > > > Tiny, at most a few dozen rows and columns in the Jacobin. > > > > > > > > You should run without the -snes_test_display information, what does it say? Does it indicate the Jacobian or report there is likely a problem? > > > > > > > > With DMDA you can also use -snes_fd_color to have PETSc compute the Jacobian for you instead of using your analytical form. If it works with this, but not your Jacobian then your Jacobian is wrong. > > > > > > > > > When I try to run the program with -snes_type test -snes_test_display, I get errors like: > > > > > > > > > > [0]PETSC ERROR: Argument out of range [0]PETSC ERROR: Local index 1076396032 too large 4979879 (max) at 0 > > > > > > > > > > The second size is 1 less than the number of field elements, while the first number seems too large for any aspect of the problem - the Jacobian has at most 59 non-zero columns per row. > > > > > > > > > > Because I suspect a possible error in the Jacobian, I ran with -snes_mf_operator -pc_type ksp -ksp_ksp_rtol 1e-12 and observed very similar failure to converge (diverging residual) as with the explicit Jacobian. > > > > > > > > What do you get with -ksp_monitor -ksp_ksp_monitor it sounds like the true Jacobian is either very ill-conditioned or your function evaluation is wrong. > > > > > > > > > Do I need to set an SNES method which is somehow compatible with the "matrix-free" approach? If I instead use -snes_mf, the problem seems to converge, but horrendously slowly (true residual relative decrease by about 1e-5 per iteration). I suppose this supports my suspicion that the Jacobian is incorrect but doesn't really suggest a solution. > > > > > > > > > > Is it possible that the analytical Jacobian is correct, but somehow pathological, which causes the SNES to diverge? > > > > > > > > Yes > > > > > > > > > Neither the Jacobian nor the function have singularities. > > > > > > > > > > Thanks for any help you can provide! > > > > > > > > Try really hard to set up a small problem (like just use a very coarse grid) to experiment with as you try to get convergence. Using a big problem for debugging convergence is a recipe for pain. > > > > > > > > Also since you have a Jacobian I would start with -snes_fd_color -snes_type ls -snes_monitor -snes_linesearch_monitor -ksp_monitor -pc_type lu (not on a huge problem), what happens? Send the output > > > > > > > > Barry > > > > > > > > > > > > > > > > > > > > > > > > > > From bsmith at mcs.anl.gov Sun Aug 27 16:51:03 2017 From: bsmith at mcs.anl.gov (Barry Smith) Date: Sun, 27 Aug 2017 16:51:03 -0500 Subject: [petsc-users] A number of questions about DMDA with SNES and Quasi-Newton methods In-Reply-To: References: <020DAED9-AAAD-4741-976B-BB2EF6C79D3F@mcs.anl.gov> <5BF530F6-8D79-47E6-B2C5-B0702FF2AA59@mcs.anl.gov> <7EE84495-4346-4BFB-B9AD-BCAA3C722461@mcs.anl.gov> Message-ID: <08AA1273-062D-4FDD-8709-40AA1FE8AA92@mcs.anl.gov> Sorry this a flaw with the current release. Call MatSetOption(jac,MAT_NEW_NONZERO_LOCATION_ERR,PETSC_FALSE) before the call to the solver. > On Aug 27, 2017, at 12:54 PM, zakaryah . wrote: > > Is it suspicious that the KSP converges so quickly? I have no experience with how the solvers behave on such small grids. > > Also, I ran the code with -snes_type test on a very small grid (1530 elements). The simpler version of the PDE ran fine, and showed good agreement of the matrices. However, the more complicated version crashes with the following errors: > > Testing hand-coded Jacobian, if the ratio is > > O(1.e-8), the hand-coded Jacobian is probably correct. > > Run with -snes_test_display to show difference > > of hand-coded and finite difference Jacobian. > > [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- > > [0]PETSC ERROR: Argument out of range > > [0]PETSC ERROR: Inserting a new nonzero at (7,0) in the matrix > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. > > [0]PETSC ERROR: Petsc Release Version 3.7.3, Jul, 24, 2016 > > [0]PETSC ERROR: #1 MatSetValues_SeqAIJ() line 484 in /PETSc/build/petsc-3.7.3/src/mat/impls/aij/seq/aij.c > > [0]PETSC ERROR: #2 MatSetValues() line 1190 in /PETSc/build/petsc-3.7.3/src/mat/interface/matrix.c > > [0]PETSC ERROR: #3 MatSetValuesLocal() line 2053 in /PETSc/build/petsc-3.7.3/src/mat/interface/matrix.c > > [0]PETSC ERROR: #4 MatSetValuesStencil() line 1447 in /PETSc/build/petsc-3.7.3/src/mat/interface/matrix.c > > Does this indicate a bug in the Jacobian calculation? I don't think I set values outside of the stencil... > > > On Sun, Aug 27, 2017 at 12:14 AM, zakaryah . wrote: > Sure - it was this: > > mpiexec -n 1 -snes_fd_color -snes_type newtonls -snes_monitor -snes_linesearch_monitor -ksp_monitor -pc_type lu > > On Sun, Aug 27, 2017 at 12:11 AM, Barry Smith wrote: > > > On Aug 26, 2017, at 10:55 PM, zakaryah . wrote: > > > > Yes, except I changed "-snes_type ls" to "-snes_type newtonls" because PETSc complained that ls wasn't a known method. > > Sorry, my memory is not as good as it used to be; but what other options did you use? Send the exact command line. > > > Barry > ' > > > > On Sat, Aug 26, 2017 at 11:52 PM, Barry Smith wrote: > > > > My exact options did you run with? > > > > > On Aug 26, 2017, at 10:48 PM, zakaryah . wrote: > > > > > > Here's the output, from the data set which does not converge with l-bfgs: > > > > > > 0 SNES Function norm 1.370293318432e+04 > > > 0 KSP Residual norm 7.457506389218e+02 > > > 1 KSP Residual norm 2.244764079994e-10 > > > Line search: gnorm after quadratic fit 6.541298279196e+05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.963717927372e+04 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.788909416707e+04 lambda=2.5000000000000001e-02 > > > Line search: Cubically determined step, current gnorm 1.340565762719e+04 lambda=1.2500000000000001e-02 > > > 1 SNES Function norm 1.340565762719e+04 > > > 0 KSP Residual norm 4.096066553372e+02 > > > 1 KSP Residual norm 3.313671167444e-11 > > > Line search: gnorm after quadratic fit 1.113749573695e+06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.406390140546e+05 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.126781917443e+04 lambda=2.5000000000000001e-02 > > > Line search: Cubically determined step, current gnorm 1.272988597973e+04 lambda=1.2500000000000001e-02 > > > 2 SNES Function norm 1.272988597973e+04 > > > 0 KSP Residual norm 8.291344597817e+01 > > > 1 KSP Residual norm 7.182258362182e-12 > > > Line search: gnorm after quadratic fit 1.121913743889e+04 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 3 SNES Function norm 1.121913743889e+04 > > > 0 KSP Residual norm 6.830535877014e+01 > > > 1 KSP Residual norm 3.629826411580e-12 > > > Line search: gnorm after quadratic fit 9.966344973786e+03 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 4 SNES Function norm 9.966344973786e+03 > > > 0 KSP Residual norm 5.137691531345e+01 > > > 1 KSP Residual norm 1.954502098181e-12 > > > Line search: gnorm after quadratic fit 8.905508641232e+03 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 5 SNES Function norm 8.905508641232e+03 > > > 0 KSP Residual norm 4.295019262963e+01 > > > 1 KSP Residual norm 1.581527994925e-12 > > > Line search: gnorm after quadratic fit 7.599173694189e+03 > > > Line search: Quadratically determined step, lambda=1.4157226463489950e-01 > > > 6 SNES Function norm 7.599173694189e+03 > > > 0 KSP Residual norm 3.520472291520e+01 > > > 1 KSP Residual norm 1.169994130568e-12 > > > Line search: gnorm after quadratic fit 6.797214843928e+03 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 7 SNES Function norm 6.797214843928e+03 > > > 0 KSP Residual norm 2.683523206056e+01 > > > 1 KSP Residual norm 9.039858014119e-13 > > > Line search: gnorm after quadratic fit 6.098038917364e+03 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 8 SNES Function norm 6.098038917364e+03 > > > 0 KSP Residual norm 2.300710560681e+01 > > > 1 KSP Residual norm 1.010402303464e-12 > > > Line search: gnorm after quadratic fit 5.486151385552e+03 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 9 SNES Function norm 5.486151385552e+03 > > > 0 KSP Residual norm 2.824628827619e+01 > > > 1 KSP Residual norm 1.009589866569e-12 > > > Line search: gnorm after quadratic fit 4.964991021247e+03 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 10 SNES Function norm 4.964991021247e+03 > > > 0 KSP Residual norm 6.285926028595e+01 > > > 1 KSP Residual norm 2.833546214180e-12 > > > Line search: gnorm after quadratic fit 2.100041391472e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.804051080767e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 4.893296169579e+03 lambda=2.5000000000000001e-02 > > > 11 SNES Function norm 4.893296169579e+03 > > > 0 KSP Residual norm 1.688978282804e+01 > > > 1 KSP Residual norm 5.927677470786e-13 > > > Line search: gnorm after quadratic fit 4.400894622431e+03 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 12 SNES Function norm 4.400894622431e+03 > > > 0 KSP Residual norm 1.481197699600e+01 > > > 1 KSP Residual norm 4.522572128105e-13 > > > Line search: Using full step: fnorm 4.400894622431e+03 gnorm 2.094971849007e+03 > > > 13 SNES Function norm 2.094971849007e+03 > > > 0 KSP Residual norm 3.514164563318e+00 > > > 1 KSP Residual norm 3.022385947499e-13 > > > Line search: gnorm after quadratic fit 1.687641025382e+03 > > > Line search: Quadratically determined step, lambda=2.0307116693368590e-01 > > > 14 SNES Function norm 1.687641025382e+03 > > > 0 KSP Residual norm 2.138591884686e+00 > > > 1 KSP Residual norm 4.023500814078e-14 > > > Line search: Using full step: fnorm 1.687641025382e+03 gnorm 1.131934218470e+03 > > > 15 SNES Function norm 1.131934218470e+03 > > > 0 KSP Residual norm 3.245035110327e+00 > > > 1 KSP Residual norm 1.293626215269e-13 > > > Line search: Using full step: fnorm 1.131934218470e+03 gnorm 7.340573607307e+02 > > > 16 SNES Function norm 7.340573607307e+02 > > > 0 KSP Residual norm 1.957698957904e+00 > > > 1 KSP Residual norm 3.444648967078e-13 > > > Line search: Using full step: fnorm 7.340573607307e+02 gnorm 5.024723505168e+02 > > > 17 SNES Function norm 5.024723505168e+02 > > > 0 KSP Residual norm 2.510538703839e+00 > > > 1 KSP Residual norm 8.570440675253e-14 > > > Line search: gnorm after quadratic fit 4.548776456608e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 18 SNES Function norm 4.548776456608e+02 > > > 0 KSP Residual norm 6.741705718178e-01 > > > 1 KSP Residual norm 1.650556120809e-14 > > > Line search: Using full step: fnorm 4.548776456608e+02 gnorm 1.351189086642e+02 > > > 19 SNES Function norm 1.351189086642e+02 > > > 0 KSP Residual norm 7.653741241950e+00 > > > 1 KSP Residual norm 8.326848236950e-14 > > > Line search: gnorm after quadratic fit 4.215455105006e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.889750369356e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.358691836999e+02 lambda=1.0303015930243279e-02 > > > Line search: Cubically determined step, current gnorm 1.348911963390e+02 lambda=3.5279526770504110e-03 > > > 20 SNES Function norm 1.348911963390e+02 > > > 0 KSP Residual norm 4.209281176918e+00 > > > 1 KSP Residual norm 1.233232881375e-13 > > > Line search: gnorm after quadratic fit 1.860023264470e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.413911132196e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.339597869053e+02 lambda=1.5787957598629023e-02 > > > 21 SNES Function norm 1.339597869053e+02 > > > 0 KSP Residual norm 1.718484765841e+00 > > > 1 KSP Residual norm 6.666016296543e-14 > > > Line search: gnorm after quadratic fit 1.326878521472e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 22 SNES Function norm 1.326878521472e+02 > > > 0 KSP Residual norm 1.515373499919e+00 > > > 1 KSP Residual norm 2.259154130795e-12 > > > Line search: gnorm after quadratic fit 1.226907316391e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 23 SNES Function norm 1.226907316391e+02 > > > 0 KSP Residual norm 1.080252936903e+00 > > > 1 KSP Residual norm 1.847020526683e-14 > > > Line search: gnorm after quadratic fit 1.163632111851e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 24 SNES Function norm 1.163632111851e+02 > > > 0 KSP Residual norm 2.491746958382e+00 > > > 1 KSP Residual norm 6.389134193637e-14 > > > Line search: gnorm after quadratic fit 1.345487153563e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.169738363622e+02 lambda=4.4108900954515480e-02 > > > Line search: Cubically determined step, current gnorm 1.152177638108e+02 lambda=1.9997442889243631e-02 > > > 25 SNES Function norm 1.152177638108e+02 > > > 0 KSP Residual norm 5.364385501004e+00 > > > 1 KSP Residual norm 8.457149562463e-14 > > > Line search: gnorm after quadratic fit 2.722095758964e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.480946353374e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.150680255994e+02 lambda=6.3560128131639167e-03 > > > 26 SNES Function norm 1.150680255994e+02 > > > 0 KSP Residual norm 4.302025268263e+00 > > > 1 KSP Residual norm 1.017526937941e-13 > > > Line search: gnorm after quadratic fit 1.956300983573e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.318600522939e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.147123505014e+02 lambda=7.6060788653548803e-03 > > > 27 SNES Function norm 1.147123505014e+02 > > > 0 KSP Residual norm 6.195463111324e+00 > > > 1 KSP Residual norm 1.235283250361e-13 > > > Line search: gnorm after quadratic fit 3.324821547049e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.612593208504e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.147389525772e+02 lambda=6.1750939181374294e-03 > > > Line search: Cubically determined step, current gnorm 1.145411432123e+02 lambda=3.0078592586792975e-03 > > > 28 SNES Function norm 1.145411432123e+02 > > > 0 KSP Residual norm 1.454704250187e+01 > > > 1 KSP Residual norm 2.368485174123e-13 > > > Line search: gnorm after quadratic fit 1.216293873116e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.796524621727e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.359314163651e+02 lambda=1.4867675803955788e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.146009802557e+02 lambda=1.4867675803955788e-03 > > > Line search: Cubically determined step, current gnorm 1.145096815033e+02 lambda=5.5250912472932839e-04 > > > 29 SNES Function norm 1.145096815033e+02 > > > 0 KSP Residual norm 3.430451345093e+01 > > > 1 KSP Residual norm 1.069396165938e-12 > > > Line search: gnorm after quadratic fit 1.161329407098e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.260690718050e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.696806489042e+02 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.960149915648e+02 lambda=1.1276129246469476e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.158113641658e+02 lambda=1.5873910451430554e-03 > > > Line search: Cubically determined step, current gnorm 1.145062232916e+02 lambda=1.5873910451430555e-04 > > > 30 SNES Function norm 1.145062232916e+02 > > > 0 KSP Residual norm 2.662578971526e+01 > > > 1 KSP Residual norm 5.464011789728e-13 > > > Line search: gnorm after quadratic fit 4.375119254490e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.038018103928e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.169328002874e+02 lambda=2.3789161387159519e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.262835432714e+02 lambda=5.9737415571960795e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.145626045197e+02 lambda=5.9737415571960802e-04 > > > Line search: Cubically determined step, current gnorm 1.144968604079e+02 lambda=1.6421773527706333e-04 > > > 31 SNES Function norm 1.144968604079e+02 > > > 0 KSP Residual norm 6.322033697338e+01 > > > 1 KSP Residual norm 1.507157991448e-12 > > > Line search: gnorm after quadratic fit 5.809243699277e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.460487584142e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.893183483197e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.960337007072e+02 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.771527792790e+02 lambda=5.3912931685137378e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.150137639707e+02 lambda=5.3912931685137376e-04 > > > Line search: Cubically determined step, current gnorm 1.144964484571e+02 lambda=5.3912931685137380e-05 > > > 32 SNES Function norm 1.144964484571e+02 > > > 0 KSP Residual norm 3.859510930996e+01 > > > 1 KSP Residual norm 8.069118044382e-13 > > > Line search: gnorm after quadratic fit 1.106329930525e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.155884463041e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.933963819094e+02 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.849629797377e+02 lambda=9.7744286136270241e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.150857687050e+02 lambda=9.7744286136270254e-04 > > > Line search: Cubically determined step, current gnorm 1.144922906340e+02 lambda=9.7744286136270254e-05 > > > 33 SNES Function norm 1.144922906340e+02 > > > 0 KSP Residual norm 4.952038022394e+01 > > > 1 KSP Residual norm 7.460263245424e-13 > > > Line search: gnorm after quadratic fit 3.005091127220e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.229308416025e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.138600794682e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.390856262238e+02 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.394997214983e+02 lambda=4.4582997750629580e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.146836358799e+02 lambda=4.4582997750629581e-04 > > > Line search: Cubically determined step, current gnorm 1.144895966587e+02 lambda=4.7644082443915877e-05 > > > 34 SNES Function norm 1.144895966587e+02 > > > 0 KSP Residual norm 1.146914786457e+02 > > > 1 KSP Residual norm 4.791627042400e-12 > > > Line search: gnorm after quadratic fit 2.601294145944e+05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.324148513778e+04 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.247478406023e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.200340900661e+03 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.696223112300e+02 lambda=6.1514413845115794e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.342365431983e+02 lambda=1.7502929694284564e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.146686063035e+02 lambda=1.7502929694284566e-04 > > > Line search: Cubically determined step, current gnorm 1.144895868489e+02 lambda=1.7502929694284566e-05 > > > 35 SNES Function norm 1.144895868489e+02 > > > 0 KSP Residual norm 6.311017209658e+01 > > > 1 KSP Residual norm 8.384445939117e-13 > > > Line search: gnorm after quadratic fit 5.781533400572e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.419557746031e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.886081770030e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.945810143740e+02 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.767820854837e+02 lambda=5.3859001959289735e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.150034040559e+02 lambda=5.3859001959289732e-04 > > > Line search: Cubically determined step, current gnorm 1.144891501665e+02 lambda=5.3859001959289732e-05 > > > 36 SNES Function norm 1.144891501665e+02 > > > 0 KSP Residual norm 3.880748384332e+01 > > > 1 KSP Residual norm 6.400339290453e-13 > > > Line search: gnorm after quadratic fit 1.122504184426e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.180728237366e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.987870621566e+02 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.863711604331e+02 lambda=9.8150771384688824e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.150916783781e+02 lambda=9.8150771384688824e-04 > > > Line search: Cubically determined step, current gnorm 1.144850837411e+02 lambda=9.8150771384688832e-05 > > > 37 SNES Function norm 1.144850837411e+02 > > > 0 KSP Residual norm 4.811537498557e+01 > > > 1 KSP Residual norm 9.738167670242e-13 > > > Line search: gnorm after quadratic fit 2.784098355218e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.885118868254e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.074843354348e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.255202820836e+02 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.365202996130e+02 lambda=4.3204204582016374e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.146504919412e+02 lambda=4.3204204582016374e-04 > > > Line search: Cubically determined step, current gnorm 1.144822306241e+02 lambda=5.0376546850227848e-05 > > > 38 SNES Function norm 1.144822306241e+02 > > > 0 KSP Residual norm 1.120914002482e+02 > > > 1 KSP Residual norm 5.452125292284e-12 > > > Line search: gnorm after quadratic fit 2.427186680567e+05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.112196656857e+04 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.967397366072e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.149551659770e+03 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.529630886791e+02 lambda=6.0885216927030559e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.315267519231e+02 lambda=1.6656233536183130e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.146353659250e+02 lambda=1.6656233536183130e-04 > > > Line search: Cubically determined step, current gnorm 1.144820487391e+02 lambda=1.6656233536183130e-05 > > > 39 SNES Function norm 1.144820487391e+02 > > > 0 KSP Residual norm 7.182416170980e+01 > > > 1 KSP Residual norm 1.292147133333e-12 > > > Line search: gnorm after quadratic fit 8.255331293322e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.302939895170e+04 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.501228089911e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.185010378583e+02 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.088179821424e+02 lambda=5.7489510178867142e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.168272901121e+02 lambda=9.7452649444612811e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144951972300e+02 lambda=9.7452649444612822e-05 > > > Line search: Cubically determined step, current gnorm 1.144807676687e+02 lambda=2.2399506502463798e-05 > > > 40 SNES Function norm 1.144807676687e+02 > > > 0 KSP Residual norm 1.728679810285e+02 > > > 1 KSP Residual norm 3.878068639716e-12 > > > Line search: gnorm after quadratic fit 9.011020578535e+05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.111818830011e+05 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.504789858103e+04 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.754312133162e+03 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.212492111975e+02 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.199969180537e+02 lambda=2.6424184504193135e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.154794639440e+02 lambda=2.6424184504193136e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144880673342e+02 lambda=2.6424184504193136e-05 > > > Line search: Cubically determined step, current gnorm 1.144805461570e+02 lambda=3.8712107591125690e-06 > > > 41 SNES Function norm 1.144805461570e+02 > > > 0 KSP Residual norm 4.162780846202e+02 > > > 1 KSP Residual norm 1.732341544934e-11 > > > Line search: gnorm after quadratic fit 1.355673864369e+07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.747523002884e+06 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.342205048417e+05 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.425635699680e+04 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.882150659178e+03 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.259664786336e+03 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.653670676209e+02 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.453655830144e+02 lambda=5.8237455565260388e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.147659525018e+02 lambda=5.8237455565260393e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144827915995e+02 lambda=5.8237455565260400e-06 > > > Line search: Cubically determined step, current gnorm 1.144805080017e+02 lambda=6.6689295146509104e-07 > > > 42 SNES Function norm 1.144805080017e+02 > > > 0 KSP Residual norm 1.004135512581e+03 > > > 1 KSP Residual norm 3.867626041000e-09 > > > Line search: gnorm after quadratic fit 1.832578994882e+08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.269698278878e+07 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.792476589915e+06 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.420660371083e+05 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.321686926168e+04 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.548358078234e+03 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.429504802276e+03 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.317723385004e+02 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.460079723095e+02 lambda=2.5078917343692407e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.147908977725e+02 lambda=2.5078917343692408e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144833604238e+02 lambda=2.5078917343692412e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144805106824e+02 lambda=2.5078917343692411e-07 > > > Line search: Cubically determined step, current gnorm 1.144805014337e+02 lambda=1.1468707119027746e-07 > > > 43 SNES Function norm 1.144805014337e+02 > > > 0 KSP Residual norm 2.418614573592e+03 > > > 1 KSP Residual norm 6.085078742847e-10 > > > Line search: gnorm after quadratic fit 2.598476259775e+09 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.262759415873e+08 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.116845970403e+07 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.250465130250e+06 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.863493884574e+05 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.501468163771e+04 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.482658980483e+04 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.802395557883e+03 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.788149582374e+02 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.248828337038e+02 lambda=1.8333058767960295e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.186285836222e+02 lambda=3.7550993478654105e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.145209710139e+02 lambda=3.7550993478654107e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144808670668e+02 lambda=3.7550993478654111e-07 > > > Line search: Cubically determined step, current gnorm 1.144805012252e+02 lambda=3.7550993478654114e-08 > > > 44 SNES Function norm 1.144805012252e+02 > > > 0 KSP Residual norm 1.432476672735e+03 > > > 1 KSP Residual norm 7.850524783892e-11 > > > Line search: gnorm after quadratic fit 5.336191593632e+08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.625576866625e+07 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.181408387845e+06 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.003310644422e+06 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.236384273292e+05 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.658430638069e+04 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.977463068161e+03 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.674238499253e+02 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.333616820791e+02 lambda=3.3764776729281175e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.161349153752e+02 lambda=4.0497161764116874e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144966925969e+02 lambda=4.0497161764116874e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144806214839e+02 lambda=4.0497161764116878e-07 > > > Line search: Cubically determined step, current gnorm 1.144804979966e+02 lambda=5.6339112427782378e-08 > > > 45 SNES Function norm 1.144804979966e+02 > > > 0 KSP Residual norm 3.453401579761e+03 > > > 1 KSP Residual norm 4.197968028126e-09 > > > Line search: gnorm after quadratic fit 7.554006183767e+09 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.471974940372e+08 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.191613865049e+08 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.509784334249e+07 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.943752478560e+06 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.597601716755e+05 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.775572331075e+04 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.418045407608e+03 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.357066758731e+03 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.859267839080e+02 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.501494912160e+02 lambda=7.5160826909319168e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.148144926477e+02 lambda=7.5160826909319171e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144837498478e+02 lambda=7.5160826909319179e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144805227746e+02 lambda=7.5160826909319182e-08 > > > Line search: Cubically determined step, current gnorm 1.144804974438e+02 lambda=9.6864021663644795e-09 > > > 46 SNES Function norm 1.144804974438e+02 > > > 0 KSP Residual norm 8.345139428850e+03 > > > 1 KSP Residual norm 1.027819754739e-09 > > > Line search: gnorm after quadratic fit 1.061319903906e+11 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.325012985379e+10 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.652236226640e+09 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.055533971630e+08 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.546607716763e+07 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.134442858835e+06 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.839168570687e+05 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.830568178626e+04 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.201776786081e+03 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.540520468013e+03 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.573504890506e+02 lambda=9.7656250000000005e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.516203908013e+02 lambda=3.2703670177372021e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.148480075676e+02 lambda=3.2703670177372022e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144841475328e+02 lambda=3.2703670177372023e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144805305720e+02 lambda=3.2703670177372021e-08 > > > Line search: Cubically determined step, current gnorm 1.144804974367e+02 lambda=3.2703670177372025e-09 > > > 47 SNES Function norm 1.144804974367e+02 > > > 0 KSP Residual norm 4.668983500382e+03 > > > 1 KSP Residual norm 1.398997665317e-09 > > > Line search: gnorm after quadratic fit 1.865309565532e+10 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.336975299727e+09 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.934905088739e+08 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.704520478641e+07 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.728477809448e+06 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.193001670096e+05 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.610673238239e+04 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.354711683605e+04 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.589557246433e+03 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.367851970709e+02 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.136930269795e+02 lambda=9.0316845802227864e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.172186635069e+02 lambda=1.5831613287181393e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.145074017254e+02 lambda=1.5831613287181394e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144807499816e+02 lambda=1.5831613287181396e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144804983345e+02 lambda=1.5831613287181397e-08 > > > Line search: Cubically determined step, current gnorm 1.144804971346e+02 lambda=5.2932921109871310e-09 > > > 48 SNES Function norm 1.144804971346e+02 > > > 0 KSP Residual norm 1.132678078317e+04 > > > 1 KSP Residual norm 2.477518733314e-10 > > > Line search: gnorm after quadratic fit 2.654659022365e+11 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.315296223725e+10 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.136635677074e+09 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.152507060235e+08 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.397060094478e+07 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.898362012287e+06 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.685179520906e+05 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.194040779842e+05 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.606415730227e+04 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.902698091972e+03 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.521549384652e+02 lambda=9.7656250000000005e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.288999778994e+02 lambda=4.1899746703195281e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.157880829786e+02 lambda=4.5470218451893824e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144935741206e+02 lambda=4.5470218451893828e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144806232638e+02 lambda=4.5470218451893831e-08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144804979250e+02 lambda=4.5470218451893835e-09 > > > Line search: Cubically determined step, current gnorm 1.144804970825e+02 lambda=9.0293679903918216e-10 > > > 49 SNES Function norm 1.144804970825e+02 > > > 0 KSP Residual norm 2.712544829144e+04 > > > 1 KSP Residual norm 4.949246309677e-09 > > > Line search: gnorm after quadratic fit 3.650846005745e+12 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.565321055911e+11 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.711080201118e+10 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.150022242308e+09 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.965954117985e+08 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.128096393645e+08 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.429702091584e+07 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.841819946536e+06 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.465032956946e+05 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.594210253794e+04 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.141110278944e+03 lambda=9.7656250000000005e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.306952279045e+03 lambda=4.8828125000000003e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.754164864338e+02 lambda=2.4414062500000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.476861367158e+02 lambda=9.2451761406722810e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.147929263780e+02 lambda=9.2451761406722810e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144836022952e+02 lambda=9.2451761406722821e-08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144805271860e+02 lambda=9.2451761406722831e-09 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144804972895e+02 lambda=9.2451761406722839e-10 > > > Line search: Cubically determined step, current gnorm 1.144804970737e+02 lambda=1.5633616333063305e-10 > > > 50 SNES Function norm 1.144804970737e+02 > > > 0 SNES Function norm 2.308693894796e+03 > > > 0 KSP Residual norm 8.981999720532e+00 > > > 1 KSP Residual norm 2.363170936183e-13 > > > Line search: Using full step: fnorm 2.308693894796e+03 gnorm 7.571661187318e+02 > > > 1 SNES Function norm 7.571661187318e+02 > > > 0 KSP Residual norm 2.149614048903e+00 > > > 1 KSP Residual norm 9.511247057888e-13 > > > Line search: Using full step: fnorm 7.571661187318e+02 gnorm 4.450081004997e+02 > > > 2 SNES Function norm 4.450081004997e+02 > > > 0 KSP Residual norm 1.706469075123e+01 > > > 1 KSP Residual norm 5.803815175472e-13 > > > Line search: gnorm after quadratic fit 1.510518198899e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.850796532980e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.515983139755e+02 lambda=2.0602556887689423e-02 > > > Line search: Cubically determined step, current gnorm 4.434800867235e+02 lambda=8.2396279492937211e-03 > > > 3 SNES Function norm 4.434800867235e+02 > > > 0 KSP Residual norm 3.208587171626e+00 > > > 1 KSP Residual norm 1.099072610659e-13 > > > Line search: gnorm after quadratic fit 4.080637194736e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 4 SNES Function norm 4.080637194736e+02 > > > 0 KSP Residual norm 8.136557176540e+00 > > > 1 KSP Residual norm 8.800137844173e-13 > > > Line search: gnorm after quadratic fit 5.261656549654e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.131114070934e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 4.031614746044e+02 lambda=2.4674842039461482e-02 > > > 5 SNES Function norm 4.031614746044e+02 > > > 0 KSP Residual norm 7.609918907567e+00 > > > 1 KSP Residual norm 1.613159932655e-13 > > > Line search: gnorm after quadratic fit 5.353908064984e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.110480554132e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 3.991168240716e+02 lambda=2.3079500036735322e-02 > > > 6 SNES Function norm 3.991168240716e+02 > > > 0 KSP Residual norm 3.800845472041e+00 > > > 1 KSP Residual norm 4.841682188278e-13 > > > Line search: gnorm after quadratic fit 3.787886582952e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 7 SNES Function norm 3.787886582952e+02 > > > 0 KSP Residual norm 1.892621919219e+00 > > > 1 KSP Residual norm 3.576655371800e-12 > > > Line search: gnorm after quadratic fit 3.440181918909e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 8 SNES Function norm 3.440181918909e+02 > > > 0 KSP Residual norm 3.559759789147e+00 > > > 1 KSP Residual norm 8.347521826622e-13 > > > Line search: gnorm after quadratic fit 3.287993515195e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 9 SNES Function norm 3.287993515195e+02 > > > 0 KSP Residual norm 1.825073540507e+00 > > > 1 KSP Residual norm 8.352745008123e-14 > > > Line search: Using full step: fnorm 3.287993515195e+02 gnorm 2.710650507416e+02 > > > 10 SNES Function norm 2.710650507416e+02 > > > 0 KSP Residual norm 7.568432945608e-01 > > > 1 KSP Residual norm 2.780715252274e-14 > > > Line search: Using full step: fnorm 2.710650507416e+02 gnorm 1.513359047342e+02 > > > 11 SNES Function norm 1.513359047342e+02 > > > 0 KSP Residual norm 9.387460484575e+00 > > > 1 KSP Residual norm 7.091233040676e-13 > > > Line search: gnorm after quadratic fit 3.998857979851e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.060972049714e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.512140169420e+02 lambda=5.4338709720680610e-03 > > > 12 SNES Function norm 1.512140169420e+02 > > > 0 KSP Residual norm 4.399424360499e+00 > > > 1 KSP Residual norm 1.614362118182e-13 > > > Line search: gnorm after quadratic fit 1.913552832643e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.559719302467e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.499985374733e+02 lambda=1.7102027220313589e-02 > > > 13 SNES Function norm 1.499985374733e+02 > > > 0 KSP Residual norm 3.740397849742e+00 > > > 1 KSP Residual norm 8.986775577006e-13 > > > Line search: gnorm after quadratic fit 1.764118876632e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.522381536119e+02 lambda=4.8196830215713270e-02 > > > Line search: Cubically determined step, current gnorm 1.486175880390e+02 lambda=1.8881300948189364e-02 > > > 14 SNES Function norm 1.486175880390e+02 > > > 0 KSP Residual norm 6.067973818528e+00 > > > 1 KSP Residual norm 4.527845229549e-13 > > > Line search: gnorm after quadratic fit 2.514021299115e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.679972156573e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.481015724304e+02 lambda=9.0116621678703428e-03 > > > 15 SNES Function norm 1.481015724304e+02 > > > 0 KSP Residual norm 6.108754994263e+00 > > > 1 KSP Residual norm 2.557635976440e-13 > > > Line search: gnorm after quadratic fit 2.458081150104e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.681837029397e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.476148340442e+02 lambda=7.9580911933571953e-03 > > > 16 SNES Function norm 1.476148340442e+02 > > > 0 KSP Residual norm 7.914946163932e+00 > > > 1 KSP Residual norm 1.512066885699e-13 > > > Line search: gnorm after quadratic fit 3.458938604598e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.883018868359e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.474286108114e+02 lambda=6.7262521208543979e-03 > > > 17 SNES Function norm 1.474286108114e+02 > > > 0 KSP Residual norm 5.285449532689e+00 > > > 1 KSP Residual norm 6.693733977456e-12 > > > Line search: gnorm after quadratic fit 2.170263102661e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.607560548008e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.467785507822e+02 lambda=9.9244383205188240e-03 > > > 18 SNES Function norm 1.467785507822e+02 > > > 0 KSP Residual norm 8.124903695635e+00 > > > 1 KSP Residual norm 2.322439601127e-11 > > > Line search: gnorm after quadratic fit 3.589716592364e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.907315184877e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.466341888638e+02 lambda=6.5538271222582893e-03 > > > 19 SNES Function norm 1.466341888638e+02 > > > 0 KSP Residual norm 5.253550718343e+00 > > > 1 KSP Residual norm 1.575657996883e-12 > > > Line search: gnorm after quadratic fit 2.155795776725e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.598564001687e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.459869404602e+02 lambda=9.9195822632931301e-03 > > > 20 SNES Function norm 1.459869404602e+02 > > > 0 KSP Residual norm 8.405987790193e+00 > > > 1 KSP Residual norm 2.046159481178e-13 > > > Line search: gnorm after quadratic fit 3.767908298426e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.941885062002e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.458995232755e+02 lambda=6.4359684554015136e-03 > > > 21 SNES Function norm 1.458995232755e+02 > > > 0 KSP Residual norm 5.036348246593e+00 > > > 1 KSP Residual norm 3.645081669075e-13 > > > Line search: gnorm after quadratic fit 2.083222977519e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.575737508694e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.452039802458e+02 lambda=1.0554092389542354e-02 > > > 22 SNES Function norm 1.452039802458e+02 > > > 0 KSP Residual norm 8.562292355998e+00 > > > 1 KSP Residual norm 3.256332645483e-13 > > > Line search: gnorm after quadratic fit 3.869470823355e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.959483128249e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.451523830598e+02 lambda=6.3780526507799607e-03 > > > 23 SNES Function norm 1.451523830598e+02 > > > 0 KSP Residual norm 4.919667503862e+00 > > > 1 KSP Residual norm 4.823931177115e-13 > > > Line search: gnorm after quadratic fit 2.042891039525e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.560623102934e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.444331916523e+02 lambda=1.0890355421223689e-02 > > > 24 SNES Function norm 1.444331916523e+02 > > > 0 KSP Residual norm 8.727282395369e+00 > > > 1 KSP Residual norm 7.090683582186e-13 > > > Line search: gnorm after quadratic fit 3.977929422821e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.978556223200e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.444215965394e+02 lambda=6.3477766966048947e-03 > > > 25 SNES Function norm 1.444215965394e+02 > > > 0 KSP Residual norm 4.759732971179e+00 > > > 1 KSP Residual norm 7.539889498211e-13 > > > Line search: gnorm after quadratic fit 1.990589649135e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.542648241555e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.436629416941e+02 lambda=1.1434720389464151e-02 > > > 26 SNES Function norm 1.436629416941e+02 > > > 0 KSP Residual norm 8.844861828477e+00 > > > 1 KSP Residual norm 4.372001279689e-13 > > > Line search: gnorm after quadratic fit 4.055598972133e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.990820671396e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.436827663113e+02 lambda=6.3302081701296859e-03 > > > Line search: Cubically determined step, current gnorm 1.434397789472e+02 lambda=3.1285674619640730e-03 > > > 27 SNES Function norm 1.434397789472e+02 > > > 0 KSP Residual norm 2.168630760128e+01 > > > 1 KSP Residual norm 3.975838928402e-13 > > > Line search: gnorm after quadratic fit 1.655681371309e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.972331169594e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.804118272840e+02 lambda=1.6710557456633125e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.435928635079e+02 lambda=1.6710557456633126e-03 > > > Line search: Cubically determined step, current gnorm 1.434032742903e+02 lambda=5.1357350159978810e-04 > > > 28 SNES Function norm 1.434032742903e+02 > > > 0 KSP Residual norm 5.259508821923e+01 > > > 1 KSP Residual norm 1.358381204928e-11 > > > Line search: gnorm after quadratic fit 1.908330224731e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.431279702545e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.060945045253e+02 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.791318323447e+02 lambda=1.2124172979783788e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.491140019897e+02 lambda=2.6952165802905347e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434246250245e+02 lambda=2.6952165802905350e-04 > > > Line search: Cubically determined step, current gnorm 1.433970449422e+02 lambda=8.6980371578986910e-05 > > > 29 SNES Function norm 1.433970449422e+02 > > > 0 KSP Residual norm 1.326287161615e+02 > > > 1 KSP Residual norm 5.692176796134e-12 > > > Line search: gnorm after quadratic fit 2.077891749832e+05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.654187989332e+04 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.213029457851e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.001385334742e+03 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.323976827250e+02 lambda=5.9607661619885998e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.489839529892e+02 lambda=1.0476257410701045e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434396736634e+02 lambda=1.0476257410701046e-04 > > > Line search: Cubically determined step, current gnorm 1.433960671821e+02 lambda=1.3664867646895530e-05 > > > 30 SNES Function norm 1.433960671821e+02 > > > 0 KSP Residual norm 3.320710360189e+02 > > > 1 KSP Residual norm 1.365660123102e-11 > > > Line search: gnorm after quadratic fit 3.597335441013e+06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.714766420450e+05 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.566809766217e+04 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.038660363150e+04 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.026997416957e+03 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.382653551072e+02 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.071747386385e+02 lambda=1.3384948046761360e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.439693866777e+02 lambda=1.3384948046761360e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434000505249e+02 lambda=1.3384948046761361e-05 > > > Line search: Cubically determined step, current gnorm 1.433959111179e+02 lambda=2.1771867000079373e-06 > > > 31 SNES Function norm 1.433959111179e+02 > > > 0 KSP Residual norm 8.385024273664e+02 > > > 1 KSP Residual norm 2.688330817732e-11 > > > Line search: gnorm after quadratic fit 5.487352481970e+07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.776642694838e+06 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.310551423141e+05 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.023322644608e+05 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.368662233379e+04 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.472194884015e+03 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.718801059897e+02 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.274234972424e+02 lambda=6.3064412238487922e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.442194384053e+02 lambda=6.3064412238487925e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434033578642e+02 lambda=6.3064412238487927e-06 > > > Line search: Cubically determined step, current gnorm 1.433959042208e+02 lambda=6.3064412238487929e-07 > > > 32 SNES Function norm 1.433959042208e+02 > > > 0 KSP Residual norm 5.310191626867e+02 > > > 1 KSP Residual norm 2.270033897601e-10 > > > Line search: gnorm after quadratic fit 1.447633783740e+07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.859761774309e+06 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.472992503503e+05 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.557594026810e+04 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.969012939380e+03 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.269212161982e+03 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.859005100842e+02 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.695095262046e+02 lambda=5.4509037994531233e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.436389958907e+02 lambda=5.4509037994531237e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433976258223e+02 lambda=5.4509037994531242e-06 > > > Line search: Cubically determined step, current gnorm 1.433958431980e+02 lambda=8.5124820362933632e-07 > > > 33 SNES Function norm 1.433958431980e+02 > > > 0 KSP Residual norm 1.341142541825e+03 > > > 1 KSP Residual norm 4.194815344365e-11 > > > Line search: gnorm after quadratic fit 2.256410317099e+08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.797696259877e+07 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.447237377751e+06 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.221898175722e+05 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.260244723327e+04 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.539148524881e+03 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.558034531173e+03 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.788188892302e+02 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.753621043454e+02 lambda=2.4427125599600652e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.437122397600e+02 lambda=2.4427125599600654e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433986985128e+02 lambda=2.4427125599600655e-06 > > > Line search: Cubically determined step, current gnorm 1.433958402293e+02 lambda=2.4427125599600656e-07 > > > 34 SNES Function norm 1.433958402293e+02 > > > 0 KSP Residual norm 8.620962950418e+02 > > > 1 KSP Residual norm 4.517777375659e-11 > > > Line search: gnorm after quadratic fit 6.134442313460e+07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.790495969255e+06 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.008365220843e+06 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.364572513478e+05 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.037891335918e+04 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.640571521199e+03 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.472549649319e+02 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.906041216274e+02 lambda=7.6348458761785112e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.504925859329e+02 lambda=1.7740973415567094e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434632637071e+02 lambda=1.7740973415567094e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433962847027e+02 lambda=1.7740973415567095e-06 > > > Line search: Cubically determined step, current gnorm 1.433958170795e+02 lambda=3.2293255704969003e-07 > > > 35 SNES Function norm 1.433958170795e+02 > > > 0 KSP Residual norm 2.177497039945e+03 > > > 1 KSP Residual norm 8.546235181505e-11 > > > Line search: gnorm after quadratic fit 9.689178330938e+08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.204850731541e+08 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.491460480376e+07 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.833699292784e+06 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.246639021599e+05 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.860166571872e+04 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.484329051490e+03 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.050411687443e+03 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.488366972009e+02 lambda=3.7767265396089055e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.508326035050e+02 lambda=7.2725649346261757e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434696063559e+02 lambda=7.2725649346261764e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433964618996e+02 lambda=7.2725649346261768e-07 > > > Line search: Cubically determined step, current gnorm 1.433958141405e+02 lambda=7.2725649346261771e-08 > > > 36 SNES Function norm 1.433958141405e+02 > > > 0 KSP Residual norm 2.164813477994e+03 > > > 1 KSP Residual norm 1.148881458292e-10 > > > Line search: gnorm after quadratic fit 9.626940870744e+08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.210459267934e+08 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.531855101756e+07 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.966826097072e+06 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.611808255272e+05 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.746062783262e+04 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.252259871244e+03 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.319447372021e+03 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.963055448218e+02 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.719034797105e+02 lambda=1.3935000445038475e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.436664111092e+02 lambda=1.3935000445038476e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433983336239e+02 lambda=1.3935000445038476e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958213497e+02 lambda=1.3935000445038476e-07 > > > Line search: Cubically determined step, current gnorm 1.433958104705e+02 lambda=5.1202466521517630e-08 > > > 37 SNES Function norm 1.433958104705e+02 > > > 0 KSP Residual norm 5.470482746849e+03 > > > 1 KSP Residual norm 2.077456833170e-10 > > > Line search: gnorm after quadratic fit 1.541335606193e+10 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.922526157954e+09 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.393079394383e+08 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.967573549050e+07 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.657319925168e+06 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.479516204895e+05 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.573399122917e+04 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.931177424479e+03 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.619710606187e+03 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.924551713717e+02 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.786095404459e+02 lambda=6.2808469554243522e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.437467476469e+02 lambda=6.2808469554243527e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433992463439e+02 lambda=6.2808469554243527e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958367271e+02 lambda=6.2808469554243525e-08 > > > Line search: Cubically determined step, current gnorm 1.433958098948e+02 lambda=8.0208105170108588e-09 > > > 38 SNES Function norm 1.433958098948e+02 > > > 0 KSP Residual norm 1.380568582849e+04 > > > 1 KSP Residual norm 3.830866223513e-10 > > > Line search: gnorm after quadratic fit 2.484973518314e+11 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.108953896984e+10 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.893104137528e+09 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.884003910853e+08 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.150765563542e+07 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.811161146103e+06 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.011017986781e+06 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.368084343451e+05 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.042876665700e+04 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.648735196752e+03 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.489051252413e+02 lambda=9.7656250000000005e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.910677756717e+02 lambda=4.7728537787817724e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.505452645186e+02 lambda=1.1099980464343249e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434658984864e+02 lambda=1.1099980464343249e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433964956476e+02 lambda=1.1099980464343249e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958153212e+02 lambda=1.1099980464343250e-08 > > > Line search: Cubically determined step, current gnorm 1.433958098048e+02 lambda=1.2587012037197021e-09 > > > 39 SNES Function norm 1.433958098048e+02 > > > 0 KSP Residual norm 3.492284741552e+04 > > > 1 KSP Residual norm 2.459788921244e-09 > > > Line search: gnorm after quadratic fit 4.017424324975e+12 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.020053801097e+11 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.270768402853e+10 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.827801904036e+09 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.758550488105e+08 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.213492627852e+08 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.502191365805e+07 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.846947104704e+06 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.262850216093e+05 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.879926646684e+04 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.510203332079e+03 lambda=9.7656250000000005e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.055028679619e+03 lambda=4.8828125000000003e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.503903269554e+02 lambda=2.3633949212111800e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.510245991472e+02 lambda=4.5897967908360529e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434724062782e+02 lambda=4.5897967908360533e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433965706606e+02 lambda=4.5897967908360533e-08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958168196e+02 lambda=4.5897967908360538e-09 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958098155e+02 lambda=4.5897967908360540e-10 > > > Line search: Cubically determined step, current gnorm 1.433958097906e+02 lambda=1.9745369723997599e-10 > > > 40 SNES Function norm 1.433958097906e+02 > > > 0 KSP Residual norm 8.722495521587e+04 > > > 1 KSP Residual norm 3.742695919275e-09 > > > Line search: gnorm after quadratic fit 6.262538457180e+13 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.829256308992e+12 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.789282877890e+11 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.224340679566e+11 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.532137613500e+10 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.919506047737e+09 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.410488718338e+08 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.042211373104e+07 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.881986305609e+06 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.080857001861e+05 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.054449734307e+04 lambda=9.7656250000000005e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.109051581397e+04 lambda=4.8828125000000003e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.144985497099e+03 lambda=2.4414062500000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.617627947761e+02 lambda=1.2207031250000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.132828960986e+02 lambda=5.3137869181552773e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.440403409760e+02 lambda=5.3137869181552777e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434022226216e+02 lambda=5.3137869181552781e-08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958732177e+02 lambda=5.3137869181552781e-09 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958103569e+02 lambda=5.3137869181552779e-10 > > > Line search: Cubically determined step, current gnorm 1.433958097894e+02 lambda=5.3137869181552781e-11 > > > 41 SNES Function norm 1.433958097894e+02 > > > 0 KSP Residual norm 6.453169081212e+04 > > > 1 KSP Residual norm 2.762540688686e-09 > > > Line search: gnorm after quadratic fit 2.535166112592e+13 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.168366990040e+12 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.958985371462e+11 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.945064622488e+10 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.172244865713e+09 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.693002384290e+08 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.562568994785e+07 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.182957296890e+07 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.453260254263e+06 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.781984147743e+05 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.294934468515e+04 lambda=9.7656250000000005e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.740461720782e+03 lambda=4.8828125000000003e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.162621855154e+02 lambda=2.4414062500000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.042417294890e+02 lambda=1.1290474210136388e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.458920680477e+02 lambda=1.4201366604660443e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434208620254e+02 lambda=1.4201366604660444e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433960586269e+02 lambda=1.4201366604660445e-08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958120934e+02 lambda=1.4201366604660445e-09 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958097940e+02 lambda=1.4201366604660446e-10 > > > Line search: Cubically determined step, current gnorm 1.433958097852e+02 lambda=5.7981795207229486e-11 > > > 42 SNES Function norm 1.433958097852e+02 > > > 0 KSP Residual norm 1.596625793747e+05 > > > 1 KSP Residual norm 6.465899717071e-09 > > > Line search: gnorm after quadratic fit 3.840699863976e+14 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.801237514773e+13 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.002454410823e+12 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.505340831651e+11 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.387378188418e+10 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.174857842415e+10 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.472211181784e+09 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.849608933788e+08 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.336592011613e+07 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.988079805895e+06 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.930858080425e+05 lambda=9.7656250000000005e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.521190722497e+04 lambda=4.8828125000000003e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.872153015323e+03 lambda=2.4414062500000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.772337662956e+03 lambda=1.2207031250000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.879470852054e+02 lambda=6.1035156250000003e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.942774855488e+02 lambda=2.4957912736226801e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.438719078958e+02 lambda=2.4957912736226800e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434005516391e+02 lambda=2.4957912736226800e-08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958568732e+02 lambda=2.4957912736226803e-09 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958102244e+02 lambda=2.4957912736226804e-10 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958097865e+02 lambda=2.4957912736226805e-11 > > > Line search: Cubically determined step, current gnorm 1.433958097846e+02 lambda=9.2900433293108317e-12 > > > 43 SNES Function norm 1.433958097846e+02 > > > 0 KSP Residual norm 4.230869747157e+05 > > > 1 KSP Residual norm 2.238707423027e-08 > > > Line search: gnorm after quadratic fit 7.145700515048e+15 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.931871281700e+14 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.116420341041e+14 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.395366610168e+13 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.743811756566e+12 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.178776103292e+11 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.721012032848e+10 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.395186924428e+09 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.229125978585e+08 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.250971135953e+07 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.483856203094e+06 lambda=9.7656250000000005e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.950671355228e+05 lambda=4.8828125000000003e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.795408218555e+04 lambda=2.4414062500000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.315025696280e+04 lambda=1.2207031250000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.395961070555e+03 lambda=6.1035156250000003e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.565070307576e+02 lambda=3.0517578125000002e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.228949713871e+02 lambda=1.2154989071946628e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.441831998014e+02 lambda=1.2154989071946629e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434037055996e+02 lambda=1.2154989071946630e-08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958886074e+02 lambda=1.2154989071946630e-09 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958105564e+02 lambda=1.2154989071946630e-10 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958097907e+02 lambda=1.2154989071946631e-11 > > > Line search: Cubically determined step, current gnorm 1.433958097845e+02 lambda=1.3559489351735629e-12 > > > 44 SNES Function norm 1.433958097845e+02 > > > 0 KSP Residual norm 1.017589039922e+06 > > > 1 KSP Residual norm 5.483283808994e-08 > > > Line search: gnorm after quadratic fit 9.942386816509e+16 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.242813073279e+16 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.553553149772e+15 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.942033483320e+14 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.427772097758e+13 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.035291372732e+12 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.795558047824e+11 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.748073147307e+10 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.944235240368e+09 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.453550734860e+08 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.377045707707e+07 lambda=9.7656250000000005e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.188119937132e+07 lambda=4.8828125000000003e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.529730353136e+06 lambda=2.4414062500000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.044646611329e+05 lambda=1.2207031250000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.974477616118e+04 lambda=6.1035156250000003e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.087923877078e+03 lambda=3.0517578125000002e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.112257173311e+03 lambda=1.5258789062500001e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.536190077033e+02 lambda=7.6293945312500004e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.622567424729e+02 lambda=2.4244966960965791e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.435780438142e+02 lambda=2.4244966960965793e-08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433976282603e+02 lambda=2.4244966960965796e-09 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958279382e+02 lambda=2.4244966960965797e-10 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958099632e+02 lambda=2.4244966960965799e-11 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958097860e+02 lambda=2.4244966960965801e-12 > > > Line search: Cubically determined step, current gnorm 1.433958097845e+02 lambda=2.4244966960965801e-13 > > > 45 SNES Function norm 1.433958097845e+02 > > > 0 KSP Residual norm 2.206687220910e+06 > > > 1 KSP Residual norm 4.897651438902e-08 > > > Line search: gnorm after quadratic fit 1.013883843512e+18 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.267347883019e+17 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.584167551460e+16 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.980166189110e+15 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.475099638694e+14 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.093604443378e+13 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.866330988164e+12 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.831230804145e+11 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.034848618023e+10 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.533173457427e+09 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.390937545910e+08 lambda=9.7656250000000005e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.167706366282e+08 lambda=4.8828125000000003e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.445357932595e+07 lambda=2.4414062500000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.776833600920e+06 lambda=1.2207031250000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.177171496134e+05 lambda=6.1035156250000003e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.775750596740e+04 lambda=3.0517578125000002e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.374283858049e+03 lambda=1.5258789062500001e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.030949543491e+03 lambda=7.6293945312500004e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.423064811256e+02 lambda=3.6673216108643130e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.499924205417e+02 lambda=6.7541706529544844e-08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434620968378e+02 lambda=6.7541706529544851e-09 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433964732224e+02 lambda=6.7541706529544853e-10 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958164087e+02 lambda=6.7541706529544856e-11 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958098496e+02 lambda=6.7541706529544860e-12 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958097850e+02 lambda=6.7541706529544869e-13 > > > Line search: unable to find good step length! After 24 tries > > > Line search: fnorm=1.4339580978447020e+02, gnorm=1.4339580978501337e+02, ynorm=2.2066872446260620e+06, minlambda=9.9999999999999998e-13, lambda=6.7541706529544869e-13, initial slope=-2.0562359199040133e+04 > > > 0 SNES Function norm 7.494832241120e+03 > > > 0 KSP Residual norm 2.096735360816e+01 > > > 1 KSP Residual norm 1.310027756820e-12 > > > Line search: gnorm after quadratic fit 6.728375857515e+03 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 1 SNES Function norm 6.728375857515e+03 > > > 0 KSP Residual norm 2.051806116405e+01 > > > 1 KSP Residual norm 4.624620138831e-13 > > > Line search: gnorm after quadratic fit 6.028616261650e+03 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 2 SNES Function norm 6.028616261650e+03 > > > 0 KSP Residual norm 2.416503160016e+01 > > > 1 KSP Residual norm 8.456041680630e-13 > > > Line search: gnorm after quadratic fit 5.407473517447e+03 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 3 SNES Function norm 5.407473517447e+03 > > > 0 KSP Residual norm 1.429873750399e+01 > > > 1 KSP Residual norm 2.956316145819e-13 > > > Line search: Using full step: fnorm 5.407473517447e+03 gnorm 1.894530516076e+03 > > > 4 SNES Function norm 1.894530516076e+03 > > > 0 KSP Residual norm 2.898580554597e+00 > > > 1 KSP Residual norm 6.622560162623e-14 > > > Line search: Using full step: fnorm 1.894530516076e+03 gnorm 1.794029421846e+03 > > > 5 SNES Function norm 1.794029421846e+03 > > > 0 KSP Residual norm 1.749678611959e+01 > > > 1 KSP Residual norm 8.138905825078e-12 > > > Line search: gnorm after quadratic fit 1.767361408940e+03 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 6 SNES Function norm 1.767361408940e+03 > > > 0 KSP Residual norm 1.094404109423e+02 > > > 1 KSP Residual norm 7.696691527700e-12 > > > Line search: gnorm after quadratic fit 3.545750923895e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.153479540314e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.205683629874e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.802976525485e+03 lambda=1.2441094586006883e-02 > > > Line search: Cubically determined step, current gnorm 1.765063299263e+03 lambda=4.9240328094708914e-03 > > > 7 SNES Function norm 1.765063299263e+03 > > > 0 KSP Residual norm 1.778095975189e+01 > > > 1 KSP Residual norm 2.814661813934e-12 > > > Line search: gnorm after quadratic fit 2.620761680117e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.793045753271e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.740299227935e+03 lambda=2.5000000000000001e-02 > > > 8 SNES Function norm 1.740299227935e+03 > > > 0 KSP Residual norm 3.284236894535e+02 > > > 1 KSP Residual norm 5.172103783952e-10 > > > Line search: gnorm after quadratic fit 2.857820523902e+05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.063993491139e+04 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.588139591650e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.491163684413e+03 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.802614760566e+03 lambda=5.7977212395253904e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.741444490992e+03 lambda=1.8448315876950813e-03 > > > Line search: Cubically determined step, current gnorm 1.739663656043e+03 lambda=7.7468345598227730e-04 > > > 9 SNES Function norm 1.739663656043e+03 > > > 0 KSP Residual norm 4.581839103558e+02 > > > 1 KSP Residual norm 2.627035885943e-11 > > > Line search: gnorm after quadratic fit 8.199478499066e+05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.127270076812e+05 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.816774161281e+04 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.053723877333e+03 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.971814513392e+03 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.755066208174e+03 lambda=2.7232010924558834e-03 > > > Line search: Cubically determined step, current gnorm 1.739559834479e+03 lambda=8.1458417855297680e-04 > > > 10 SNES Function norm 1.739559834479e+03 > > > 0 KSP Residual norm 1.463056810139e+02 > > > 1 KSP Residual norm 5.383584598825e-12 > > > Line search: gnorm after quadratic fit 2.885699620595e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.847717401708e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.244464170034e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.769157604338e+03 lambda=1.0857209099577540e-02 > > > Line search: Cubically determined step, current gnorm 1.737356225452e+03 lambda=4.0312937622950231e-03 > > > 11 SNES Function norm 1.737356225452e+03 > > > 0 KSP Residual norm 1.564105677925e+02 > > > 1 KSP Residual norm 6.671164745832e-11 > > > Line search: gnorm after quadratic fit 3.815800291873e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.197027796134e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.373151605545e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.783976520867e+03 lambda=1.2093374970461970e-02 > > > Line search: Cubically determined step, current gnorm 1.735737929915e+03 lambda=4.9529698477569920e-03 > > > 12 SNES Function norm 1.735737929915e+03 > > > 0 KSP Residual norm 5.030757139645e+01 > > > 1 KSP Residual norm 1.157542730692e-12 > > > Line search: gnorm after quadratic fit 3.004544441458e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.850403239750e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.722893188305e+03 lambda=2.0881992439921702e-02 > > > 13 SNES Function norm 1.722893188305e+03 > > > 0 KSP Residual norm 7.123428853845e+01 > > > 1 KSP Residual norm 8.671726774894e-12 > > > Line search: gnorm after quadratic fit 4.361041499279e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.032697222107e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.726212330814e+03 lambda=1.9909470348267504e-02 > > > Line search: Cubically determined step, current gnorm 1.714127356920e+03 lambda=9.9547351741337518e-03 > > > 14 SNES Function norm 1.714127356920e+03 > > > 0 KSP Residual norm 8.304557447257e+00 > > > 1 KSP Residual norm 6.268295862688e-13 > > > Line search: gnorm after quadratic fit 1.558163002487e+03 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 15 SNES Function norm 1.558163002487e+03 > > > 0 KSP Residual norm 2.820803287164e+00 > > > 1 KSP Residual norm 5.477413853752e-13 > > > Line search: gnorm after quadratic fit 1.065673478530e+03 > > > Line search: Quadratically determined step, lambda=3.8943438938591052e-01 > > > 16 SNES Function norm 1.065673478530e+03 > > > 0 KSP Residual norm 2.296739120664e+00 > > > 1 KSP Residual norm 6.273731899885e-14 > > > Line search: gnorm after quadratic fit 8.964342150621e+02 > > > Line search: Quadratically determined step, lambda=1.8740736900935545e-01 > > > 17 SNES Function norm 8.964342150621e+02 > > > 0 KSP Residual norm 5.567568505830e+00 > > > 1 KSP Residual norm 8.649083600764e-12 > > > Line search: gnorm after quadratic fit 8.322514858992e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 18 SNES Function norm 8.322514858992e+02 > > > 0 KSP Residual norm 1.164393577210e+00 > > > 1 KSP Residual norm 2.019248309015e-14 > > > Line search: Using full step: fnorm 8.322514858992e+02 gnorm 3.179750274746e+02 > > > 19 SNES Function norm 3.179750274746e+02 > > > 0 KSP Residual norm 5.339294310641e+00 > > > 1 KSP Residual norm 2.070321587238e-13 > > > Line search: gnorm after quadratic fit 3.433012316833e+02 > > > Line search: Cubically determined step, current gnorm 3.140305403821e+02 lambda=5.0000000000000003e-02 > > > 20 SNES Function norm 3.140305403821e+02 > > > 0 KSP Residual norm 1.177016565578e+01 > > > 1 KSP Residual norm 2.413027540446e-13 > > > Line search: gnorm after quadratic fit 7.377851778409e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.896721016582e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 3.136619309181e+02 lambda=9.7219892278716195e-03 > > > 21 SNES Function norm 3.136619309181e+02 > > > 0 KSP Residual norm 3.973565083977e+00 > > > 1 KSP Residual norm 9.726786674410e-14 > > > Line search: gnorm after quadratic fit 3.098277326090e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 22 SNES Function norm 3.098277326090e+02 > > > 0 KSP Residual norm 9.389290683519e+00 > > > 1 KSP Residual norm 1.651497163724e-13 > > > Line search: gnorm after quadratic fit 6.887970540455e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.588146381477e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.099274823603e+02 lambda=1.6890426151283184e-02 > > > Line search: Cubically determined step, current gnorm 3.084890760827e+02 lambda=8.4452130756415920e-03 > > > 23 SNES Function norm 3.084890760827e+02 > > > 0 KSP Residual norm 2.381130479641e+00 > > > 1 KSP Residual norm 4.694489283156e-14 > > > Line search: gnorm after quadratic fit 2.872151876535e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 24 SNES Function norm 2.872151876535e+02 > > > 0 KSP Residual norm 2.405498502269e+00 > > > 1 KSP Residual norm 3.316846070538e-13 > > > Line search: gnorm after quadratic fit 2.686789761232e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 25 SNES Function norm 2.686789761232e+02 > > > 0 KSP Residual norm 1.728772970554e+00 > > > 1 KSP Residual norm 4.132974383339e-14 > > > Line search: gnorm after quadratic fit 2.365009918229e+02 > > > Line search: Quadratically determined step, lambda=1.7273357529379074e-01 > > > 26 SNES Function norm 2.365009918229e+02 > > > 0 KSP Residual norm 4.413764759374e+00 > > > 1 KSP Residual norm 5.210690816917e-14 > > > Line search: gnorm after quadratic fit 2.756730968257e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.372321757171e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 2.335020811250e+02 lambda=2.5000000000000001e-02 > > > 27 SNES Function norm 2.335020811250e+02 > > > 0 KSP Residual norm 1.606246507553e+00 > > > 1 KSP Residual norm 3.564847846678e-14 > > > Line search: gnorm after quadratic fit 2.078263630653e+02 > > > Line search: Quadratically determined step, lambda=1.5913860995949433e-01 > > > 28 SNES Function norm 2.078263630653e+02 > > > 0 KSP Residual norm 3.700632954873e+00 > > > 1 KSP Residual norm 5.113863400264e-13 > > > Line search: gnorm after quadratic fit 2.142503514807e+02 > > > Line search: Cubically determined step, current gnorm 2.021095009118e+02 lambda=5.0000000000000003e-02 > > > 29 SNES Function norm 2.021095009118e+02 > > > 0 KSP Residual norm 3.056449560135e+00 > > > 1 KSP Residual norm 3.207987681334e-14 > > > Line search: gnorm after quadratic fit 2.064252530802e+02 > > > Line search: Cubically determined step, current gnorm 1.978069081639e+02 lambda=5.0000000000000003e-02 > > > 30 SNES Function norm 1.978069081639e+02 > > > 0 KSP Residual norm 2.024695620703e+00 > > > 1 KSP Residual norm 5.460360737995e-14 > > > Line search: gnorm after quadratic fit 1.839556530796e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 31 SNES Function norm 1.839556530796e+02 > > > 0 KSP Residual norm 1.610676619931e+01 > > > 1 KSP Residual norm 6.703552136307e-13 > > > Line search: gnorm after quadratic fit 7.186735314913e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.905672430097e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.856766286600e+02 lambda=1.0830798014298563e-02 > > > Line search: Cubically determined step, current gnorm 1.836818937131e+02 lambda=3.3207362501459785e-03 > > > 32 SNES Function norm 1.836818937131e+02 > > > 0 KSP Residual norm 7.471722173131e+01 > > > 1 KSP Residual norm 2.671534648829e-12 > > > Line search: gnorm after quadratic fit 9.613379909411e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.509491298762e+04 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.808861367705e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.767283758299e+02 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.665421328348e+02 lambda=6.0369453941238101e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.869726717041e+02 lambda=1.4394327006264963e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.836897704575e+02 lambda=1.4394327006264963e-04 > > > Line search: Cubically determined step, current gnorm 1.836767951408e+02 lambda=5.5567420418543164e-05 > > > 33 SNES Function norm 1.836767951408e+02 > > > 0 KSP Residual norm 2.702367712138e+01 > > > 1 KSP Residual norm 2.731656687850e-12 > > > Line search: gnorm after quadratic fit 3.331563146098e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.723694790688e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.941243220944e+02 lambda=2.1443568774664485e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.847231733910e+02 lambda=2.7571330376860012e-03 > > > Line search: Cubically determined step, current gnorm 1.836356729409e+02 lambda=4.7841280418270480e-04 > > > 34 SNES Function norm 1.836356729409e+02 > > > 0 KSP Residual norm 1.228333177997e+01 > > > 1 KSP Residual norm 2.681127387880e-13 > > > Line search: gnorm after quadratic fit 6.936329223475e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.749327218775e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.871557327742e+02 lambda=1.4160505301999991e-02 > > > Line search: Cubically determined step, current gnorm 1.833523080682e+02 lambda=3.5196326548579192e-03 > > > 35 SNES Function norm 1.833523080682e+02 > > > 0 KSP Residual norm 3.531886257396e+02 > > > 1 KSP Residual norm 2.364634092895e-11 > > > Line search: gnorm after quadratic fit 3.994783047929e+06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.753715960726e+05 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.516669898185e+04 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.918985942348e+03 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.363599250418e+03 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.344906818752e+02 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.991088183980e+02 lambda=1.0108094710462592e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.834621681844e+02 lambda=1.0108094710462593e-04 > > > Line search: Cubically determined step, current gnorm 1.833517377324e+02 lambda=1.0108094710462594e-05 > > > 36 SNES Function norm 1.833517377324e+02 > > > 0 KSP Residual norm 9.005833507118e+01 > > > 1 KSP Residual norm 6.116387880629e-12 > > > Line search: gnorm after quadratic fit 8.899847103226e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.388111536526e+04 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.532652074749e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.864912734009e+02 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.421068789960e+02 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.873498120960e+02 lambda=2.1924025345283278e-03 > > > Line search: Cubically determined step, current gnorm 1.833506987706e+02 lambda=2.1924025345283280e-04 > > > 37 SNES Function norm 1.833506987706e+02 > > > 0 KSP Residual norm 1.548426525207e+01 > > > 1 KSP Residual norm 1.038038773942e-12 > > > Line search: gnorm after quadratic fit 6.702848665441e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.789880616078e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.846521504351e+02 lambda=1.0567302644323170e-02 > > > Line search: Cubically determined step, current gnorm 1.830548481815e+02 lambda=3.5274490352771972e-03 > > > 38 SNES Function norm 1.830548481815e+02 > > > 0 KSP Residual norm 1.523095478807e+01 > > > 1 KSP Residual norm 1.963823596119e-12 > > > Line search: gnorm after quadratic fit 9.255727478491e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.496757253461e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.863126241242e+02 lambda=9.3143291632966311e-03 > > > Line search: Cubically determined step, current gnorm 1.829091761403e+02 lambda=1.8107234819462800e-03 > > > 39 SNES Function norm 1.829091761403e+02 > > > 0 KSP Residual norm 1.311320726934e+01 > > > 1 KSP Residual norm 9.084170520902e-13 > > > Line search: gnorm after quadratic fit 7.488610069188e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.691148243365e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.885558228772e+02 lambda=1.9439894235886539e-02 > > > Line search: Cubically determined step, current gnorm 1.825540619134e+02 lambda=5.4967824488704169e-03 > > > 40 SNES Function norm 1.825540619134e+02 > > > 0 KSP Residual norm 1.218635557505e+01 > > > 1 KSP Residual norm 7.760485728617e-13 > > > Line search: gnorm after quadratic fit 6.636453826807e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.880828006022e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.830493790584e+02 lambda=6.6234802648049863e-03 > > > Line search: Cubically determined step, current gnorm 1.823397545268e+02 lambda=2.4308217464828865e-03 > > > 41 SNES Function norm 1.823397545268e+02 > > > 0 KSP Residual norm 9.456543593865e+00 > > > 1 KSP Residual norm 7.046593270309e-13 > > > Line search: gnorm after quadratic fit 3.369769163110e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.105230957789e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.817897533119e+02 lambda=9.1612481372917148e-03 > > > 42 SNES Function norm 1.817897533119e+02 > > > 0 KSP Residual norm 7.290035145805e+00 > > > 1 KSP Residual norm 3.198962158141e-12 > > > Line search: gnorm after quadratic fit 2.858311567415e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.965004842981e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.808845577764e+02 lambda=1.3826421990147811e-02 > > > 43 SNES Function norm 1.808845577764e+02 > > > 0 KSP Residual norm 7.256785036157e+00 > > > 1 KSP Residual norm 9.243179217625e-14 > > > Line search: gnorm after quadratic fit 2.534388176390e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.916726818893e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.797953125543e+02 lambda=1.3677747819164022e-02 > > > 44 SNES Function norm 1.797953125543e+02 > > > 0 KSP Residual norm 1.716201096352e+01 > > > 1 KSP Residual norm 2.701418800808e-13 > > > Line search: gnorm after quadratic fit 1.331064301474e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.461842246267e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.920668830294e+02 lambda=1.2856504859057132e-02 > > > Line search: Cubically determined step, current gnorm 1.797121460957e+02 lambda=1.4396611381500967e-03 > > > 45 SNES Function norm 1.797121460957e+02 > > > 0 KSP Residual norm 6.613432967985e+00 > > > 1 KSP Residual norm 1.357752977076e-13 > > > Line search: gnorm after quadratic fit 2.721288927858e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.939638282615e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.787985482018e+02 lambda=1.2647907914070569e-02 > > > 46 SNES Function norm 1.787985482018e+02 > > > 0 KSP Residual norm 1.225736349281e+01 > > > 1 KSP Residual norm 3.819378790812e-13 > > > Line search: gnorm after quadratic fit 4.548006065036e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.304803559060e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.787344729174e+02 lambda=8.9002284237256531e-03 > > > 47 SNES Function norm 1.787344729174e+02 > > > 0 KSP Residual norm 6.302465402340e+00 > > > 1 KSP Residual norm 6.980931947122e-14 > > > Line search: gnorm after quadratic fit 2.879477700004e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.980806946742e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.780128006935e+02 lambda=1.0223293444602008e-02 > > > 48 SNES Function norm 1.780128006935e+02 > > > 0 KSP Residual norm 4.323829277968e+00 > > > 1 KSP Residual norm 5.223881369308e-13 > > > Line search: gnorm after quadratic fit 1.957928151218e+02 > > > Line search: Cubically determined step, current gnorm 1.768899805640e+02 lambda=5.0000000000000003e-02 > > > 49 SNES Function norm 1.768899805640e+02 > > > 0 KSP Residual norm 2.249256107033e+00 > > > 1 KSP Residual norm 3.624400957270e-14 > > > Line search: gnorm after quadratic fit 1.704782114773e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 50 SNES Function norm 1.704782114773e+02 > > > 0 SNES Function norm 3.513783397332e+03 > > > 0 KSP Residual norm 1.650214950648e+01 > > > 1 KSP Residual norm 3.574269752690e-13 > > > Line search: gnorm after quadratic fit 3.155830404050e+03 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 1 SNES Function norm 3.155830404050e+03 > > > 0 KSP Residual norm 1.443734018042e+01 > > > 1 KSP Residual norm 3.685565191058e-13 > > > Line search: Using full step: fnorm 3.155830404050e+03 gnorm 8.581212204155e+02 > > > 2 SNES Function norm 8.581212204155e+02 > > > 0 KSP Residual norm 2.492601775565e+00 > > > 1 KSP Residual norm 9.698440210389e-14 > > > Line search: Using full step: fnorm 8.581212204155e+02 gnorm 7.018609898542e+02 > > > 3 SNES Function norm 7.018609898542e+02 > > > 0 KSP Residual norm 1.740320986421e+00 > > > 1 KSP Residual norm 2.868780682435e-14 > > > Line search: Using full step: fnorm 7.018609898542e+02 gnorm 2.135824235887e+02 > > > 4 SNES Function norm 2.135824235887e+02 > > > 0 KSP Residual norm 1.647413497077e+00 > > > 1 KSP Residual norm 2.731226225666e-14 > > > Line search: gnorm after quadratic fit 1.936469032649e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 5 SNES Function norm 1.936469032649e+02 > > > 0 KSP Residual norm 1.406615972124e+00 > > > 1 KSP Residual norm 3.167179626699e-14 > > > Line search: gnorm after quadratic fit 1.755362571467e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 6 SNES Function norm 1.755362571467e+02 > > > 0 KSP Residual norm 1.480681706594e+00 > > > 1 KSP Residual norm 2.935210968935e-14 > > > Line search: gnorm after quadratic fit 1.597659506616e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 7 SNES Function norm 1.597659506616e+02 > > > 0 KSP Residual norm 4.013154698097e+00 > > > 1 KSP Residual norm 1.021628704832e-13 > > > Line search: gnorm after quadratic fit 1.728408060966e+02 > > > Line search: Cubically determined step, current gnorm 1.570815760721e+02 lambda=5.0000000000000003e-02 > > > 8 SNES Function norm 1.570815760721e+02 > > > 0 KSP Residual norm 1.510335662636e+00 > > > 1 KSP Residual norm 2.728243244724e-14 > > > Line search: gnorm after quadratic fit 1.450162880692e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 9 SNES Function norm 1.450162880692e+02 > > > 0 KSP Residual norm 1.923349271077e+01 > > > 1 KSP Residual norm 1.640711956406e-11 > > > Line search: gnorm after quadratic fit 1.016537223115e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.584263092048e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.490729346583e+02 lambda=9.3725990358703350e-03 > > > Line search: Cubically determined step, current gnorm 1.449349273006e+02 lambda=1.5464889706033082e-03 > > > 10 SNES Function norm 1.449349273006e+02 > > > 0 KSP Residual norm 1.154999084194e+01 > > > 1 KSP Residual norm 1.292167633338e-11 > > > Line search: gnorm after quadratic fit 6.060386918705e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.236630526035e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.491201927819e+02 lambda=1.6816056300124185e-02 > > > Line search: Cubically determined step, current gnorm 1.447023047013e+02 lambda=4.1484374564153808e-03 > > > 11 SNES Function norm 1.447023047013e+02 > > > 0 KSP Residual norm 7.278906180502e+00 > > > 1 KSP Residual norm 2.815632651924e-12 > > > Line search: gnorm after quadratic fit 2.512278711773e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.624350957814e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.441656049510e+02 lambda=1.0879389002513012e-02 > > > 12 SNES Function norm 1.441656049510e+02 > > > 0 KSP Residual norm 4.449836480267e+00 > > > 1 KSP Residual norm 3.152365624813e-13 > > > Line search: gnorm after quadratic fit 1.749680739878e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.458763435996e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.425715025152e+02 lambda=2.2766809271842225e-02 > > > 13 SNES Function norm 1.425715025152e+02 > > > 0 KSP Residual norm 4.218495037726e+00 > > > 1 KSP Residual norm 1.398472536142e-12 > > > Line search: gnorm after quadratic fit 1.645159536467e+02 > > > Line search: Cubically determined step, current gnorm 1.421991559212e+02 lambda=4.1883769431247941e-02 > > > 14 SNES Function norm 1.421991559212e+02 > > > 0 KSP Residual norm 1.968853538608e+00 > > > 1 KSP Residual norm 7.594023450519e-12 > > > Line search: gnorm after quadratic fit 1.350960142124e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 15 SNES Function norm 1.350960142124e+02 > > > 0 KSP Residual norm 3.444721686085e+00 > > > 1 KSP Residual norm 5.312609674019e-14 > > > Line search: gnorm after quadratic fit 1.472880565107e+02 > > > Line search: Cubically determined step, current gnorm 1.336714620145e+02 lambda=4.1341550820829437e-02 > > > 16 SNES Function norm 1.336714620145e+02 > > > 0 KSP Residual norm 3.276288899397e+00 > > > 1 KSP Residual norm 8.394674946715e-14 > > > Line search: gnorm after quadratic fit 1.459274497150e+02 > > > Line search: Cubically determined step, current gnorm 1.327618539486e+02 lambda=5.0000000000000003e-02 > > > 17 SNES Function norm 1.327618539486e+02 > > > 0 KSP Residual norm 2.630052244303e+00 > > > 1 KSP Residual norm 4.351283410507e-14 > > > Line search: gnorm after quadratic fit 1.350378060116e+02 > > > Line search: Cubically determined step, current gnorm 1.299403903934e+02 lambda=4.9913529436269283e-02 > > > 18 SNES Function norm 1.299403903934e+02 > > > 0 KSP Residual norm 6.124953430138e+00 > > > 1 KSP Residual norm 2.295381352938e-13 > > > Line search: gnorm after quadratic fit 2.275621676963e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.469611730657e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.294890694898e+02 lambda=1.0071939100661648e-02 > > > 19 SNES Function norm 1.294890694898e+02 > > > 0 KSP Residual norm 1.036733907011e+01 > > > 1 KSP Residual norm 1.800941381283e-13 > > > Line search: gnorm after quadratic fit 3.844879463595e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.875071148504e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.294494430642e+02 lambda=5.0000000000000010e-03 > > > 20 SNES Function norm 1.294494430642e+02 > > > 0 KSP Residual norm 8.224001595443e+00 > > > 1 KSP Residual norm 3.337810156182e-13 > > > Line search: gnorm after quadratic fit 3.332325263497e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.682441841234e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.294720538860e+02 lambda=8.5401597581228530e-03 > > > Line search: Cubically determined step, current gnorm 1.291762382985e+02 lambda=4.2555418164960989e-03 > > > 21 SNES Function norm 1.291762382985e+02 > > > 0 KSP Residual norm 3.920749219860e+01 > > > 1 KSP Residual norm 1.610902886435e-12 > > > Line search: gnorm after quadratic fit 3.472422440640e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.023065712859e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.228184088700e+02 lambda=1.6004598823093592e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.298607525058e+02 lambda=1.6004598823093593e-03 > > > Line search: Cubically determined step, current gnorm 1.291643460998e+02 lambda=1.9319076533745672e-04 > > > 22 SNES Function norm 1.291643460998e+02 > > > 0 KSP Residual norm 1.520092314848e+02 > > > 1 KSP Residual norm 7.089159192434e-11 > > > Line search: gnorm after quadratic fit 2.752539686422e+05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.237188995536e+04 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.484370498858e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.571039994484e+03 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.280898858362e+02 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.708927009106e+02 lambda=2.6114913411793973e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.294919567784e+02 lambda=2.6114913411793975e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291645609810e+02 lambda=2.6114913411793977e-05 > > > Line search: Cubically determined step, current gnorm 1.291635530596e+02 lambda=1.2278773895355162e-05 > > > 23 SNES Function norm 1.291635530596e+02 > > > 0 KSP Residual norm 7.569206058965e+02 > > > 1 KSP Residual norm 3.454693729751e-11 > > > Line search: gnorm after quadratic fit 2.570888738395e+07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.064965025187e+06 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.498514098182e+05 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.807487005202e+04 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.233167830543e+03 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.396736912757e+03 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.547572543330e+02 lambda=1.2623406091699435e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.335889024473e+02 lambda=1.8542137907683829e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.292059042479e+02 lambda=1.8542137907683831e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291637618568e+02 lambda=1.8542137907683832e-06 > > > Line search: Cubically determined step, current gnorm 1.291635210734e+02 lambda=4.9524172913414387e-07 > > > 24 SNES Function norm 1.291635210734e+02 > > > 0 KSP Residual norm 3.761913422861e+03 > > > 1 KSP Residual norm 6.181718776929e-10 > > > Line search: gnorm after quadratic fit 3.342370445037e+09 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.218326646111e+08 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.375128803204e+07 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.980626157021e+06 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.407418671219e+05 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.357321025399e+05 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.188948059047e+04 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.105117929713e+03 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.331054736818e+02 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.942479792843e+02 lambda=1.9412500272460620e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.436944624694e+02 lambda=6.4483223307578726e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.292972287211e+02 lambda=6.4483223307578726e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291647778160e+02 lambda=6.4483223307578730e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635261433e+02 lambda=6.4483223307578730e-08 > > > Line search: Cubically determined step, current gnorm 1.291635197798e+02 lambda=2.0042115918485846e-08 > > > 25 SNES Function norm 1.291635197798e+02 > > > 0 KSP Residual norm 1.874745766083e+04 > > > 1 KSP Residual norm 1.476978150334e-09 > > > Line search: gnorm after quadratic fit 4.089262111368e+11 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.101717203770e+10 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.352565940292e+09 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.879613196620e+08 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.698613558125e+07 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.175566265039e+07 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.382919964952e+06 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.545431975334e+05 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.713561369103e+04 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.031789308419e+03 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.205847020738e+02 lambda=9.7656250000000005e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.957203153158e+02 lambda=2.8132879163728503e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.297923302791e+02 lambda=2.8132879163728504e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291698100579e+02 lambda=2.8132879163728504e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635794525e+02 lambda=2.8132879163728506e-08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635200489e+02 lambda=2.8132879163728508e-09 > > > Line search: Cubically determined step, current gnorm 1.291635197275e+02 lambda=8.0832061492461345e-10 > > > 26 SNES Function norm 1.291635197275e+02 > > > 0 KSP Residual norm 9.248381077528e+04 > > > 1 KSP Residual norm 7.262307068447e-09 > > > Line search: gnorm after quadratic fit 4.920647210624e+13 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.153216818065e+12 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.697543960375e+11 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.637004379805e+10 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.208402653149e+10 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.519988135798e+09 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.923903214787e+08 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.465663001976e+07 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.238603967195e+06 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.459179143177e+05 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.676301042792e+04 lambda=9.7656250000000005e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.135808875752e+04 lambda=4.8828125000000003e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.275714918657e+03 lambda=2.4414062500000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.719037747616e+02 lambda=1.2207031250000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.039826156716e+02 lambda=5.5609199181402721e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.308092967809e+02 lambda=9.1057337296683134e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291796742824e+02 lambda=9.1057337296683134e-08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291636800174e+02 lambda=9.1057337296683134e-09 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635212255e+02 lambda=9.1057337296683134e-10 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635197320e+02 lambda=9.1057337296683139e-11 > > > Line search: Cubically determined step, current gnorm 1.291635197254e+02 lambda=3.2898162617097329e-11 > > > 27 SNES Function norm 1.291635197254e+02 > > > 0 KSP Residual norm 4.818745996826e+05 > > > 1 KSP Residual norm 3.300979345194e-08 > > > Line search: gnorm after quadratic fit 6.957046028867e+15 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.695654311477e+14 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.086793500688e+14 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.358083744813e+13 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.696584801696e+12 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.118183549773e+11 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.641372080976e+10 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.285878535769e+09 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.068045470276e+08 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.988290932539e+07 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.001404304764e+06 lambda=9.7656250000000005e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.962234585736e+05 lambda=4.8828125000000003e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.648190078115e+04 lambda=2.4414062500000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.098288624714e+03 lambda=1.2207031250000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.025132922751e+03 lambda=6.1035156250000003e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.536770142392e+02 lambda=3.0517578125000002e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.529553964021e+02 lambda=6.6615844706846272e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.293970371303e+02 lambda=6.6615844706846277e-08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291658631829e+02 lambda=6.6615844706846284e-09 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635430890e+02 lambda=6.6615844706846284e-10 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635199508e+02 lambda=6.6615844706846284e-11 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635197268e+02 lambda=6.6615844706846284e-12 > > > Line search: Cubically determined step, current gnorm 1.291635197253e+02 lambda=1.2496728806533799e-12 > > > 28 SNES Function norm 1.291635197253e+02 > > > 0 KSP Residual norm 2.124622394867e+06 > > > 1 KSP Residual norm 2.766225333896e-07 > > > Line search: gnorm after quadratic fit 5.963587884154e+17 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.454611858824e+16 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.318582340500e+15 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.164902175749e+15 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.456326197371e+14 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.820904039469e+13 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.277371273495e+12 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.849819609184e+11 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.570050545145e+10 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.482064028328e+09 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.651631635063e+08 lambda=9.7656250000000005e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.188623828904e+07 lambda=4.8828125000000003e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.302868645305e+06 lambda=2.4414062500000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.245214424313e+06 lambda=1.2207031250000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.775004618570e+05 lambda=6.1035156250000003e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.810228834086e+04 lambda=3.0517578125000002e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.148910945566e+03 lambda=1.5258789062500001e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.133679879416e+03 lambda=7.6293945312500004e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.382468615011e+02 lambda=3.8146972656250002e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.519773483633e+02 lambda=1.4103864371136453e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.293690599792e+02 lambda=1.4103864371136454e-08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291655645282e+02 lambda=1.4103864371136455e-09 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635401518e+02 lambda=1.4103864371136456e-10 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635199283e+02 lambda=1.4103864371136456e-11 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635197272e+02 lambda=1.4103864371136456e-12 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635197253e+02 lambda=1.4103864371136457e-13 > > > Line search: unable to find good step length! After 25 tries > > > Line search: fnorm=1.2916351972528861e+02, gnorm=1.2916351972529532e+02, ynorm=2.1246218291095798e+06, minlambda=9.9999999999999998e-13, lambda=1.4103864371136457e-13, initial slope=-1.6683210999382733e+04 > > > 0 SNES Function norm 7.158176401507e+03 > > > 0 KSP Residual norm 7.545626598553e+02 > > > 1 KSP Residual norm 2.192822940623e-11 > > > Line search: gnorm after quadratic fit 6.003975664723e+07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.501930637484e+06 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.380142516806e+05 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.179837352860e+05 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.656902039419e+04 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.340091686120e+03 lambda=3.1250000000000002e-03 > > > Line search: Cubically determined step, current gnorm 7.127478647243e+03 lambda=1.5625000000000001e-03 > > > 1 SNES Function norm 7.127478647243e+03 > > > 0 KSP Residual norm 3.139792512249e+01 > > > 1 KSP Residual norm 5.765552480238e-13 > > > Line search: gnorm after quadratic fit 7.131728282938e+03 > > > Line search: Cubically determined step, current gnorm 6.730387269330e+03 lambda=5.0000000000000003e-02 > > > 2 SNES Function norm 6.730387269330e+03 > > > 0 KSP Residual norm 2.247436817553e+01 > > > 1 KSP Residual norm 4.129717651221e-13 > > > Line search: gnorm after quadratic fit 6.018304311910e+03 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 3 SNES Function norm 6.018304311910e+03 > > > 0 KSP Residual norm 1.605973421081e+01 > > > 1 KSP Residual norm 3.614891198134e-13 > > > Line search: gnorm after quadratic fit 5.394599276028e+03 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 4 SNES Function norm 5.394599276028e+03 > > > 0 KSP Residual norm 1.491002227850e+01 > > > 1 KSP Residual norm 5.905756964447e-13 > > > Line search: gnorm after quadratic fit 4.845108544722e+03 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 5 SNES Function norm 4.845108544722e+03 > > > 0 KSP Residual norm 1.562997766581e+02 > > > 1 KSP Residual norm 5.722461855805e-12 > > > Line search: gnorm after quadratic fit 1.663505509947e+05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.368547472010e+04 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.067825049920e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.852173464442e+03 lambda=1.2500000000000001e-02 > > > Line search: Cubically determined step, current gnorm 4.819549937425e+03 lambda=6.2500000000000003e-03 > > > 6 SNES Function norm 4.819549937425e+03 > > > 0 KSP Residual norm 1.652787385042e+01 > > > 1 KSP Residual norm 7.774483442550e-13 > > > Line search: gnorm after quadratic fit 2.868840270198e+03 > > > Line search: Quadratically determined step, lambda=3.9586658383856743e-01 > > > 7 SNES Function norm 2.868840270198e+03 > > > 0 KSP Residual norm 1.220061851091e+01 > > > 1 KSP Residual norm 4.785407437718e-13 > > > Line search: gnorm after quadratic fit 2.616720732407e+03 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 8 SNES Function norm 2.616720732407e+03 > > > 0 KSP Residual norm 2.884722153958e+01 > > > 1 KSP Residual norm 5.474553921306e-13 > > > Line search: gnorm after quadratic fit 3.025386805317e+03 > > > Line search: Cubically determined step, current gnorm 2.572110173067e+03 lambda=5.0000000000000003e-02 > > > 9 SNES Function norm 2.572110173067e+03 > > > 0 KSP Residual norm 5.239447686736e+01 > > > 1 KSP Residual norm 1.006906008399e-12 > > > Line search: gnorm after quadratic fit 5.237562098046e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.722529781980e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 2.553072891461e+03 lambda=2.5000000000000001e-02 > > > 10 SNES Function norm 2.553072891461e+03 > > > 0 KSP Residual norm 6.511316788880e+00 > > > 1 KSP Residual norm 1.340296659008e-13 > > > Line search: gnorm after quadratic fit 2.299704119080e+03 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 11 SNES Function norm 2.299704119080e+03 > > > 0 KSP Residual norm 5.268131426587e+00 > > > 1 KSP Residual norm 1.017563310127e-13 > > > Line search: Using full step: fnorm 2.299704119080e+03 gnorm 7.642690039388e+02 > > > 12 SNES Function norm 7.642690039388e+02 > > > 0 KSP Residual norm 1.467735721574e+01 > > > 1 KSP Residual norm 1.090242963543e-12 > > > Line search: gnorm after quadratic fit 1.042766084830e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.924803860137e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 7.581126971182e+02 lambda=1.8508848315139208e-02 > > > 13 SNES Function norm 7.581126971182e+02 > > > 0 KSP Residual norm 2.222609581896e+00 > > > 1 KSP Residual norm 5.661437314341e-14 > > > Line search: gnorm after quadratic fit 6.235337602260e+02 > > > Line search: Quadratically determined step, lambda=2.1172883827013136e-01 > > > 14 SNES Function norm 6.235337602260e+02 > > > 0 KSP Residual norm 3.080209609798e+00 > > > 1 KSP Residual norm 6.073476899313e-14 > > > Line search: gnorm after quadratic fit 5.704745248520e+02 > > > Line search: Quadratically determined step, lambda=1.0142301129466913e-01 > > > 15 SNES Function norm 5.704745248520e+02 > > > 0 KSP Residual norm 5.628316803979e+00 > > > 1 KSP Residual norm 9.930477041779e-14 > > > Line search: gnorm after quadratic fit 5.401354794776e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 16 SNES Function norm 5.401354794776e+02 > > > 0 KSP Residual norm 2.052541406719e+01 > > > 1 KSP Residual norm 4.328836834239e-13 > > > Line search: gnorm after quadratic fit 1.709850100987e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.717966555703e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.414032576976e+02 lambda=8.7805694170804971e-03 > > > Line search: Cubically determined step, current gnorm 5.391967144330e+02 lambda=3.6341472475199424e-03 > > > 17 SNES Function norm 5.391967144330e+02 > > > 0 KSP Residual norm 2.246993769488e+00 > > > 1 KSP Residual norm 5.078373642913e-14 > > > Line search: gnorm after quadratic fit 4.939618639951e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 18 SNES Function norm 4.939618639951e+02 > > > 0 KSP Residual norm 2.155867648564e+00 > > > 1 KSP Residual norm 4.438622106380e-14 > > > Line search: gnorm after quadratic fit 4.334377322188e+02 > > > Line search: Quadratically determined step, lambda=1.5092486954829210e-01 > > > 19 SNES Function norm 4.334377322188e+02 > > > 0 KSP Residual norm 8.318284791610e+00 > > > 1 KSP Residual norm 6.910116607023e-13 > > > Line search: gnorm after quadratic fit 6.148799641401e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.502386288041e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 4.297879862602e+02 lambda=1.9565738732695813e-02 > > > 20 SNES Function norm 4.297879862602e+02 > > > 0 KSP Residual norm 7.593855254976e+01 > > > 1 KSP Residual norm 1.300639045149e-12 > > > Line search: gnorm after quadratic fit 7.318016560287e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.832525429452e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.543595712952e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.752901058720e+02 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.309726315570e+02 lambda=1.2500000000000002e-03 > > > Line search: Cubically determined step, current gnorm 4.297464967378e+02 lambda=2.0986409143217158e-04 > > > 21 SNES Function norm 4.297464967378e+02 > > > 0 KSP Residual norm 8.492609701850e+00 > > > 1 KSP Residual norm 2.830329105288e-13 > > > Line search: gnorm after quadratic fit 6.575200413213e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.532760802544e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 4.268212296998e+02 lambda=1.8460064973695799e-02 > > > 22 SNES Function norm 4.268212296998e+02 > > > 0 KSP Residual norm 2.527155905469e+00 > > > 1 KSP Residual norm 2.235724978394e-13 > > > Line search: gnorm after quadratic fit 3.958132075117e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 23 SNES Function norm 3.958132075117e+02 > > > 0 KSP Residual norm 3.425644398425e+00 > > > 1 KSP Residual norm 7.166017790799e-14 > > > Line search: gnorm after quadratic fit 3.803199338641e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 24 SNES Function norm 3.803199338641e+02 > > > 0 KSP Residual norm 3.581435186688e+00 > > > 1 KSP Residual norm 1.730091027109e-13 > > > Line search: gnorm after quadratic fit 3.678433353709e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 25 SNES Function norm 3.678433353709e+02 > > > 0 KSP Residual norm 2.817439291614e+00 > > > 1 KSP Residual norm 8.592333136485e-13 > > > Line search: gnorm after quadratic fit 3.472671313564e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 26 SNES Function norm 3.472671313564e+02 > > > 0 KSP Residual norm 1.830066839089e+00 > > > 1 KSP Residual norm 3.248934231575e-14 > > > Line search: gnorm after quadratic fit 3.195079998571e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 27 SNES Function norm 3.195079998571e+02 > > > 0 KSP Residual norm 3.775823654589e+00 > > > 1 KSP Residual norm 1.316233059492e-13 > > > Line search: gnorm after quadratic fit 3.252874639934e+02 > > > Line search: Cubically determined step, current gnorm 3.125168318399e+02 lambda=5.0000000000000003e-02 > > > 28 SNES Function norm 3.125168318399e+02 > > > 0 KSP Residual norm 3.892613775622e+00 > > > 1 KSP Residual norm 7.093200713216e-11 > > > Line search: gnorm after quadratic fit 3.137590389484e+02 > > > Line search: Cubically determined step, current gnorm 3.045559021319e+02 lambda=5.0000000000000003e-02 > > > 29 SNES Function norm 3.045559021319e+02 > > > 0 KSP Residual norm 2.364531179390e+00 > > > 1 KSP Residual norm 1.615423543115e-12 > > > Line search: gnorm after quadratic fit 2.864449141431e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 30 SNES Function norm 2.864449141431e+02 > > > 0 KSP Residual norm 5.187063704081e+00 > > > 1 KSP Residual norm 4.254799504045e-13 > > > Line search: gnorm after quadratic fit 3.171238299438e+02 > > > Line search: Cubically determined step, current gnorm 2.859321807369e+02 lambda=4.9550691080557742e-02 > > > 31 SNES Function norm 2.859321807369e+02 > > > 0 KSP Residual norm 2.400449127985e+01 > > > 1 KSP Residual norm 5.221032480453e-13 > > > Line search: gnorm after quadratic fit 1.812538817802e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.647888939229e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.905120335847e+02 lambda=7.3371687404129469e-03 > > > Line search: Cubically determined step, current gnorm 2.857698450683e+02 lambda=1.3231746793531958e-03 > > > 32 SNES Function norm 2.857698450683e+02 > > > 0 KSP Residual norm 7.438521293559e+00 > > > 1 KSP Residual norm 1.293652874831e-12 > > > Line search: gnorm after quadratic fit 3.600694148787e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.932936811991e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 2.832774969882e+02 lambda=1.8636088141277370e-02 > > > 33 SNES Function norm 2.832774969882e+02 > > > 0 KSP Residual norm 2.676138557891e+00 > > > 1 KSP Residual norm 5.204105674042e-12 > > > Line search: gnorm after quadratic fit 2.698470565576e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 34 SNES Function norm 2.698470565576e+02 > > > 0 KSP Residual norm 1.009562156863e+01 > > > 1 KSP Residual norm 3.544140587695e-13 > > > Line search: gnorm after quadratic fit 5.672695948559e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.197216154647e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 2.694068135292e+02 lambda=1.0762403784106927e-02 > > > 35 SNES Function norm 2.694068135292e+02 > > > 0 KSP Residual norm 3.927549314525e+00 > > > 1 KSP Residual norm 2.619134786598e-13 > > > Line search: gnorm after quadratic fit 2.646675787349e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 36 SNES Function norm 2.646675787349e+02 > > > 0 KSP Residual norm 3.630219417922e+01 > > > 1 KSP Residual norm 1.546302717349e-12 > > > Line search: gnorm after quadratic fit 1.827432666108e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.342968941151e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.008633273369e+02 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.490753494196e+02 lambda=1.2345129233072847e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.682474011960e+02 lambda=3.3291959087019770e-03 > > > Line search: Cubically determined step, current gnorm 2.646227701989e+02 lambda=4.0529212866107715e-04 > > > 37 SNES Function norm 2.646227701989e+02 > > > 0 KSP Residual norm 8.122774697994e+00 > > > 1 KSP Residual norm 1.316362046092e-13 > > > Line search: gnorm after quadratic fit 4.731092571363e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.030088374328e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 2.637462652877e+02 lambda=9.1057248517509397e-03 > > > 38 SNES Function norm 2.637462652877e+02 > > > 0 KSP Residual norm 2.601520363063e+00 > > > 1 KSP Residual norm 1.060764270007e-12 > > > Line search: gnorm after quadratic fit 2.536856446094e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 39 SNES Function norm 2.536856446094e+02 > > > 0 KSP Residual norm 5.447955134327e+01 > > > 1 KSP Residual norm 2.556989975730e-12 > > > Line search: gnorm after quadratic fit 9.199250935618e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.998238940105e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.227083769291e+02 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.852215674478e+02 lambda=8.5024965111563117e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.537821339347e+02 lambda=8.5024965111563122e-04 > > > Line search: Cubically determined step, current gnorm 2.536484146652e+02 lambda=2.9594242443314720e-04 > > > 40 SNES Function norm 2.536484146652e+02 > > > 0 KSP Residual norm 3.357359266965e+01 > > > 1 KSP Residual norm 8.485166742752e-11 > > > Line search: gnorm after quadratic fit 3.327150899857e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.660943990394e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.428891921377e+02 lambda=2.2262238648584176e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.550059920785e+02 lambda=3.9120439672600755e-03 > > > Line search: Cubically determined step, current gnorm 2.535425543202e+02 lambda=8.8078244093807846e-04 > > > 41 SNES Function norm 2.535425543202e+02 > > > 0 KSP Residual norm 1.982789391732e+01 > > > 1 KSP Residual norm 1.156473750758e-11 > > > Line search: gnorm after quadratic fit 9.648483369708e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.023504841042e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.554919970151e+02 lambda=8.7092873850291869e-03 > > > Line search: Cubically determined step, current gnorm 2.532490636747e+02 lambda=2.4564558988847251e-03 > > > 42 SNES Function norm 2.532490636747e+02 > > > 0 KSP Residual norm 1.762994613361e+01 > > > 1 KSP Residual norm 4.550684860593e-12 > > > Line search: gnorm after quadratic fit 6.772107527838e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.370541870778e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.532869639177e+02 lambda=7.7662700854918328e-03 > > > Line search: Cubically determined step, current gnorm 2.527651129995e+02 lambda=3.8686733161537824e-03 > > > 43 SNES Function norm 2.527651129995e+02 > > > 0 KSP Residual norm 1.559278923951e+01 > > > 1 KSP Residual norm 1.060470887103e-11 > > > Line search: gnorm after quadratic fit 7.344361373020e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.498001534426e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.530518382567e+02 lambda=7.6730113050967469e-03 > > > Line search: Cubically determined step, current gnorm 2.523423548732e+02 lambda=3.4156098513217236e-03 > > > 44 SNES Function norm 2.523423548732e+02 > > > 0 KSP Residual norm 1.190500639095e+01 > > > 1 KSP Residual norm 6.311739265577e-12 > > > Line search: gnorm after quadratic fit 4.875196633557e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.933215922947e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 2.516782376717e+02 lambda=9.8878729665301743e-03 > > > 45 SNES Function norm 2.516782376717e+02 > > > 0 KSP Residual norm 1.003632001309e+01 > > > 1 KSP Residual norm 7.039473047666e-13 > > > Line search: gnorm after quadratic fit 3.417133560813e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.636443273929e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 2.499729768042e+02 lambda=1.5332495922160540e-02 > > > 46 SNES Function norm 2.499729768042e+02 > > > 0 KSP Residual norm 5.252587112411e+01 > > > 1 KSP Residual norm 2.072629114336e-12 > > > Line search: gnorm after quadratic fit 7.891803681498e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.819076698717e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.911876424956e+02 lambda=2.4538865368827514e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.688195882303e+02 lambda=6.5764457912135515e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.500076295129e+02 lambda=6.5764457912135523e-04 > > > Line search: Cubically determined step, current gnorm 2.499390700783e+02 lambda=2.7231956365922875e-04 > > > 47 SNES Function norm 2.499390700783e+02 > > > 0 KSP Residual norm 4.007648116930e+01 > > > 1 KSP Residual norm 5.646654234336e-11 > > > Line search: gnorm after quadratic fit 6.276152857499e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.418274035925e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.785345842563e+02 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.665412152699e+02 lambda=8.0607289886479045e-03 > > > Line search: Cubically determined step, current gnorm 2.499109739904e+02 lambda=8.0607289886479045e-04 > > > 48 SNES Function norm 2.499109739904e+02 > > > 0 KSP Residual norm 1.339756751889e+01 > > > 1 KSP Residual norm 2.559175980945e-13 > > > Line search: gnorm after quadratic fit 6.052259901869e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.217431518450e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 2.496541765916e+02 lambda=7.0239599632283649e-03 > > > 49 SNES Function norm 2.496541765916e+02 > > > 0 KSP Residual norm 5.340771873687e+00 > > > 1 KSP Residual norm 1.207454778077e-13 > > > Line search: gnorm after quadratic fit 2.760767095070e+02 > > > Line search: Cubically determined step, current gnorm 2.491630276458e+02 lambda=5.0000000000000003e-02 > > > 50 SNES Function norm 2.491630276458e+02 > > > > > > > > > On Sat, Aug 26, 2017 at 11:45 PM, Barry Smith wrote: > > > > > > > On Aug 26, 2017, at 10:43 PM, zakaryah . wrote: > > > > > > > > Hi Barry - many thanks for taking the time to understand my many problems and providing so much help. > > > > > > > > The reason I was concerned that I could not alter the linesearch was when I tried to use bt instead of the L-BFGS default, cp, the code crashed with an error like "Could not get Jacobian". Maybe this is an incompatibility like you say, since L-BFGS only uses the initial Jacobian and I never tried setting the scale type. > > > > > > > > I took your advice and tried to shrink the problem. First I tried shrinking by a factor 1000 but this converged very quickly with all test data I could provide, including the data which was problematic with the large grid. So I settled for a reduction in size by a factor 125. The grid size is 13,230. This is a decent test case because the solver fails to converge with the options I was using before, and it is small enough that I can run it with the options you suggested (-snes_fd_color -snes_type newtonls -snes_monitor -snes_linesearch_monitor -ksp_monitor -pc_type lu). > > > > > > > > The output is 1800 lines long - how shall I share it? > > > > > > Just email it, that is small enough for email. > > > > > > Barry > > > > > > > > > > > > > > > > > > > > > > > On Sat, Aug 26, 2017 at 7:38 PM, Barry Smith wrote: > > > > > > > > > On Aug 26, 2017, at 5:56 PM, zakaryah . wrote: > > > > > > > > > > I'm using PETSc's SNES methods to solve PDEs which result from Euler-Lagrange equations for the strain energy of a 3D displacement field. There is an additional term in the Lagrangian which describes external forces which arise from various data sets, and that term contains nonlinearities (field terms higher than linear). The grid has about 1.6e6 elements, and the displacement field has 3 components at each grid element. > > > > > > > > > > I'm trying to solve a sequence of successively more complicated equations, and the latest equation is failing to converge on some data sets. In particular, the methods were successful for the infinitesimal bulk strain (compression) energy, as well as the full infinitesimal strain energy (bulk + shear), but I'm now trying to generalize to the finite strain, as certain data sets are known to result from displacement fields for which the infinitesimal strain is a poor approximation. > > > > > > > > > > I'm using a DMDA, closely following example 48, and my preferred solver is L-BFGS. > > > > > > > > So you are using ? > > > > > > > > -snes_type qn -snes_qn_type lbfgs > > > > > > > > > > > > > > I have read the FAQs "Why is Newton's method not converging??" and "Why is my iterative linear solver not converging??"? which have raised a number of questions: > > > > > > > > Quasi Newton methods either don't use Jacobians or use only the initial Jacobian (the idea behind quasi-Newton methods is to approximate Jacobian information from previous iterations without having the user compute a Jacobian at each iteration). With PETSc's qn it only uses the Jacobian if you use the option > > > > > > > > -snes_qn_scale_type Jacobian > > > > > > > > otherwise the Jacobian is never computed or used > > > > > > > > > > > > > > > > > > Is there documentation for the DMDA/SNES methods somewhere? I don't understand these very well. For example, I am not allocating any matrix for the global Jacobian, and I believe this prevents me from changing the line search. If I'm mistaken I would love to see an example of changing the line search type while using DMDA/SNES. > > > > > > > > Whether you provide a Jacobian or not is orthogonal to the line search. > > > > > > > > You should be able to change the line search with > > > > > > > > -snes_linesearch_type bt or nleqerr or basic or l2 or cp > > > > > > > > not all of them may work with qn > > > > > > > > > > > > > > > > > > I don't know how to interpret the linesearch monitor. Even for problems which are converging properly, the linesearch monitor reports "lssucceed=0" on every iteration. Is this a problem? > > > > > > > > It returns a 0 if the line search does not believe it has achieved "sufficient decrease" in the function norm (or possibly some other measure of decrease) you should run -snes_linesearch_monitor also with the option -snes_monitor to see what is happening to the function norm > > > > > > > > For qn you can add the option > > > > > > > > -snes_qn_monitor > > > > > > > > to get more detailed monitoring > > > > > > > > > > > > > > > > > > I'm also having trouble understanding the methods for troubleshooting. I suspect that I've made an error in the analytical Jacobian, which has a rather large number of non-zero elements, but I have no idea how to use -snes_type test -snes_test_display. The FAQs mention that some troubleshooting tools are more useful for small test problems. How small is small? > > > > > > > > Tiny, at most a few dozen rows and columns in the Jacobin. > > > > > > > > You should run without the -snes_test_display information, what does it say? Does it indicate the Jacobian or report there is likely a problem? > > > > > > > > With DMDA you can also use -snes_fd_color to have PETSc compute the Jacobian for you instead of using your analytical form. If it works with this, but not your Jacobian then your Jacobian is wrong. > > > > > > > > > When I try to run the program with -snes_type test -snes_test_display, I get errors like: > > > > > > > > > > [0]PETSC ERROR: Argument out of range [0]PETSC ERROR: Local index 1076396032 too large 4979879 (max) at 0 > > > > > > > > > > The second size is 1 less than the number of field elements, while the first number seems too large for any aspect of the problem - the Jacobian has at most 59 non-zero columns per row. > > > > > > > > > > Because I suspect a possible error in the Jacobian, I ran with -snes_mf_operator -pc_type ksp -ksp_ksp_rtol 1e-12 and observed very similar failure to converge (diverging residual) as with the explicit Jacobian. > > > > > > > > What do you get with -ksp_monitor -ksp_ksp_monitor it sounds like the true Jacobian is either very ill-conditioned or your function evaluation is wrong. > > > > > > > > > Do I need to set an SNES method which is somehow compatible with the "matrix-free" approach? If I instead use -snes_mf, the problem seems to converge, but horrendously slowly (true residual relative decrease by about 1e-5 per iteration). I suppose this supports my suspicion that the Jacobian is incorrect but doesn't really suggest a solution. > > > > > > > > > > Is it possible that the analytical Jacobian is correct, but somehow pathological, which causes the SNES to diverge? > > > > > > > > Yes > > > > > > > > > Neither the Jacobian nor the function have singularities. > > > > > > > > > > Thanks for any help you can provide! > > > > > > > > Try really hard to set up a small problem (like just use a very coarse grid) to experiment with as you try to get convergence. Using a big problem for debugging convergence is a recipe for pain. > > > > > > > > Also since you have a Jacobian I would start with -snes_fd_color -snes_type ls -snes_monitor -snes_linesearch_monitor -ksp_monitor -pc_type lu (not on a huge problem), what happens? Send the output > > > > > > > > Barry > > > > > > > > > > > > > > > > > > > > > > > > > From bsmith at mcs.anl.gov Sun Aug 27 17:03:43 2017 From: bsmith at mcs.anl.gov (Barry Smith) Date: Sun, 27 Aug 2017 17:03:43 -0500 Subject: [petsc-users] A number of questions about DMDA with SNES and Quasi-Newton methods In-Reply-To: References: <020DAED9-AAAD-4741-976B-BB2EF6C79D3F@mcs.anl.gov> <5BF530F6-8D79-47E6-B2C5-B0702FF2AA59@mcs.anl.gov> <7EE84495-4346-4BFB-B9AD-BCAA3C722461@mcs.anl.gov> Message-ID: <70EF3BF4-B361-4266-B8F9-275C3FD3C924@mcs.anl.gov> > On Aug 26, 2017, at 11:14 PM, zakaryah . wrote: > > Sure - it was this: > > mpiexec -n 1 -snes_fd_color -snes_type newtonls -snes_monitor -snes_linesearch_monitor -ksp_monitor -pc_type lu Ok, the fact that with the finite difference Jacobin you don't get convergence indicates there are some difficulties with this nonlinear system. The LU solver works fine so likely the Jacobian is nonsingular, but the fact that the line search is needed and gives a small step means 1) the function evaluation is a) "wrong" b) has some "discontinuities" or if tests or something that make Newton fail. 2) the function does not have any zeros, 3) the zeros are "really" far from the initial guess so Newton can never get near them. If 3) is the problem you can try to use a continuation method https://en.wikipedia.org/wiki/Numerical_continuation to try to get convergence Barry > > On Sun, Aug 27, 2017 at 12:11 AM, Barry Smith wrote: > > > On Aug 26, 2017, at 10:55 PM, zakaryah . wrote: > > > > Yes, except I changed "-snes_type ls" to "-snes_type newtonls" because PETSc complained that ls wasn't a known method. > > Sorry, my memory is not as good as it used to be; but what other options did you use? Send the exact command line. > > > Barry > ' > > > > On Sat, Aug 26, 2017 at 11:52 PM, Barry Smith wrote: > > > > My exact options did you run with? > > > > > On Aug 26, 2017, at 10:48 PM, zakaryah . wrote: > > > > > > Here's the output, from the data set which does not converge with l-bfgs: > > > > > > 0 SNES Function norm 1.370293318432e+04 > > > 0 KSP Residual norm 7.457506389218e+02 > > > 1 KSP Residual norm 2.244764079994e-10 > > > Line search: gnorm after quadratic fit 6.541298279196e+05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.963717927372e+04 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.788909416707e+04 lambda=2.5000000000000001e-02 > > > Line search: Cubically determined step, current gnorm 1.340565762719e+04 lambda=1.2500000000000001e-02 > > > 1 SNES Function norm 1.340565762719e+04 > > > 0 KSP Residual norm 4.096066553372e+02 > > > 1 KSP Residual norm 3.313671167444e-11 > > > Line search: gnorm after quadratic fit 1.113749573695e+06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.406390140546e+05 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.126781917443e+04 lambda=2.5000000000000001e-02 > > > Line search: Cubically determined step, current gnorm 1.272988597973e+04 lambda=1.2500000000000001e-02 > > > 2 SNES Function norm 1.272988597973e+04 > > > 0 KSP Residual norm 8.291344597817e+01 > > > 1 KSP Residual norm 7.182258362182e-12 > > > Line search: gnorm after quadratic fit 1.121913743889e+04 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 3 SNES Function norm 1.121913743889e+04 > > > 0 KSP Residual norm 6.830535877014e+01 > > > 1 KSP Residual norm 3.629826411580e-12 > > > Line search: gnorm after quadratic fit 9.966344973786e+03 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 4 SNES Function norm 9.966344973786e+03 > > > 0 KSP Residual norm 5.137691531345e+01 > > > 1 KSP Residual norm 1.954502098181e-12 > > > Line search: gnorm after quadratic fit 8.905508641232e+03 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 5 SNES Function norm 8.905508641232e+03 > > > 0 KSP Residual norm 4.295019262963e+01 > > > 1 KSP Residual norm 1.581527994925e-12 > > > Line search: gnorm after quadratic fit 7.599173694189e+03 > > > Line search: Quadratically determined step, lambda=1.4157226463489950e-01 > > > 6 SNES Function norm 7.599173694189e+03 > > > 0 KSP Residual norm 3.520472291520e+01 > > > 1 KSP Residual norm 1.169994130568e-12 > > > Line search: gnorm after quadratic fit 6.797214843928e+03 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 7 SNES Function norm 6.797214843928e+03 > > > 0 KSP Residual norm 2.683523206056e+01 > > > 1 KSP Residual norm 9.039858014119e-13 > > > Line search: gnorm after quadratic fit 6.098038917364e+03 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 8 SNES Function norm 6.098038917364e+03 > > > 0 KSP Residual norm 2.300710560681e+01 > > > 1 KSP Residual norm 1.010402303464e-12 > > > Line search: gnorm after quadratic fit 5.486151385552e+03 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 9 SNES Function norm 5.486151385552e+03 > > > 0 KSP Residual norm 2.824628827619e+01 > > > 1 KSP Residual norm 1.009589866569e-12 > > > Line search: gnorm after quadratic fit 4.964991021247e+03 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 10 SNES Function norm 4.964991021247e+03 > > > 0 KSP Residual norm 6.285926028595e+01 > > > 1 KSP Residual norm 2.833546214180e-12 > > > Line search: gnorm after quadratic fit 2.100041391472e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.804051080767e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 4.893296169579e+03 lambda=2.5000000000000001e-02 > > > 11 SNES Function norm 4.893296169579e+03 > > > 0 KSP Residual norm 1.688978282804e+01 > > > 1 KSP Residual norm 5.927677470786e-13 > > > Line search: gnorm after quadratic fit 4.400894622431e+03 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 12 SNES Function norm 4.400894622431e+03 > > > 0 KSP Residual norm 1.481197699600e+01 > > > 1 KSP Residual norm 4.522572128105e-13 > > > Line search: Using full step: fnorm 4.400894622431e+03 gnorm 2.094971849007e+03 > > > 13 SNES Function norm 2.094971849007e+03 > > > 0 KSP Residual norm 3.514164563318e+00 > > > 1 KSP Residual norm 3.022385947499e-13 > > > Line search: gnorm after quadratic fit 1.687641025382e+03 > > > Line search: Quadratically determined step, lambda=2.0307116693368590e-01 > > > 14 SNES Function norm 1.687641025382e+03 > > > 0 KSP Residual norm 2.138591884686e+00 > > > 1 KSP Residual norm 4.023500814078e-14 > > > Line search: Using full step: fnorm 1.687641025382e+03 gnorm 1.131934218470e+03 > > > 15 SNES Function norm 1.131934218470e+03 > > > 0 KSP Residual norm 3.245035110327e+00 > > > 1 KSP Residual norm 1.293626215269e-13 > > > Line search: Using full step: fnorm 1.131934218470e+03 gnorm 7.340573607307e+02 > > > 16 SNES Function norm 7.340573607307e+02 > > > 0 KSP Residual norm 1.957698957904e+00 > > > 1 KSP Residual norm 3.444648967078e-13 > > > Line search: Using full step: fnorm 7.340573607307e+02 gnorm 5.024723505168e+02 > > > 17 SNES Function norm 5.024723505168e+02 > > > 0 KSP Residual norm 2.510538703839e+00 > > > 1 KSP Residual norm 8.570440675253e-14 > > > Line search: gnorm after quadratic fit 4.548776456608e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 18 SNES Function norm 4.548776456608e+02 > > > 0 KSP Residual norm 6.741705718178e-01 > > > 1 KSP Residual norm 1.650556120809e-14 > > > Line search: Using full step: fnorm 4.548776456608e+02 gnorm 1.351189086642e+02 > > > 19 SNES Function norm 1.351189086642e+02 > > > 0 KSP Residual norm 7.653741241950e+00 > > > 1 KSP Residual norm 8.326848236950e-14 > > > Line search: gnorm after quadratic fit 4.215455105006e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.889750369356e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.358691836999e+02 lambda=1.0303015930243279e-02 > > > Line search: Cubically determined step, current gnorm 1.348911963390e+02 lambda=3.5279526770504110e-03 > > > 20 SNES Function norm 1.348911963390e+02 > > > 0 KSP Residual norm 4.209281176918e+00 > > > 1 KSP Residual norm 1.233232881375e-13 > > > Line search: gnorm after quadratic fit 1.860023264470e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.413911132196e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.339597869053e+02 lambda=1.5787957598629023e-02 > > > 21 SNES Function norm 1.339597869053e+02 > > > 0 KSP Residual norm 1.718484765841e+00 > > > 1 KSP Residual norm 6.666016296543e-14 > > > Line search: gnorm after quadratic fit 1.326878521472e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 22 SNES Function norm 1.326878521472e+02 > > > 0 KSP Residual norm 1.515373499919e+00 > > > 1 KSP Residual norm 2.259154130795e-12 > > > Line search: gnorm after quadratic fit 1.226907316391e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 23 SNES Function norm 1.226907316391e+02 > > > 0 KSP Residual norm 1.080252936903e+00 > > > 1 KSP Residual norm 1.847020526683e-14 > > > Line search: gnorm after quadratic fit 1.163632111851e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 24 SNES Function norm 1.163632111851e+02 > > > 0 KSP Residual norm 2.491746958382e+00 > > > 1 KSP Residual norm 6.389134193637e-14 > > > Line search: gnorm after quadratic fit 1.345487153563e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.169738363622e+02 lambda=4.4108900954515480e-02 > > > Line search: Cubically determined step, current gnorm 1.152177638108e+02 lambda=1.9997442889243631e-02 > > > 25 SNES Function norm 1.152177638108e+02 > > > 0 KSP Residual norm 5.364385501004e+00 > > > 1 KSP Residual norm 8.457149562463e-14 > > > Line search: gnorm after quadratic fit 2.722095758964e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.480946353374e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.150680255994e+02 lambda=6.3560128131639167e-03 > > > 26 SNES Function norm 1.150680255994e+02 > > > 0 KSP Residual norm 4.302025268263e+00 > > > 1 KSP Residual norm 1.017526937941e-13 > > > Line search: gnorm after quadratic fit 1.956300983573e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.318600522939e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.147123505014e+02 lambda=7.6060788653548803e-03 > > > 27 SNES Function norm 1.147123505014e+02 > > > 0 KSP Residual norm 6.195463111324e+00 > > > 1 KSP Residual norm 1.235283250361e-13 > > > Line search: gnorm after quadratic fit 3.324821547049e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.612593208504e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.147389525772e+02 lambda=6.1750939181374294e-03 > > > Line search: Cubically determined step, current gnorm 1.145411432123e+02 lambda=3.0078592586792975e-03 > > > 28 SNES Function norm 1.145411432123e+02 > > > 0 KSP Residual norm 1.454704250187e+01 > > > 1 KSP Residual norm 2.368485174123e-13 > > > Line search: gnorm after quadratic fit 1.216293873116e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.796524621727e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.359314163651e+02 lambda=1.4867675803955788e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.146009802557e+02 lambda=1.4867675803955788e-03 > > > Line search: Cubically determined step, current gnorm 1.145096815033e+02 lambda=5.5250912472932839e-04 > > > 29 SNES Function norm 1.145096815033e+02 > > > 0 KSP Residual norm 3.430451345093e+01 > > > 1 KSP Residual norm 1.069396165938e-12 > > > Line search: gnorm after quadratic fit 1.161329407098e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.260690718050e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.696806489042e+02 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.960149915648e+02 lambda=1.1276129246469476e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.158113641658e+02 lambda=1.5873910451430554e-03 > > > Line search: Cubically determined step, current gnorm 1.145062232916e+02 lambda=1.5873910451430555e-04 > > > 30 SNES Function norm 1.145062232916e+02 > > > 0 KSP Residual norm 2.662578971526e+01 > > > 1 KSP Residual norm 5.464011789728e-13 > > > Line search: gnorm after quadratic fit 4.375119254490e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.038018103928e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.169328002874e+02 lambda=2.3789161387159519e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.262835432714e+02 lambda=5.9737415571960795e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.145626045197e+02 lambda=5.9737415571960802e-04 > > > Line search: Cubically determined step, current gnorm 1.144968604079e+02 lambda=1.6421773527706333e-04 > > > 31 SNES Function norm 1.144968604079e+02 > > > 0 KSP Residual norm 6.322033697338e+01 > > > 1 KSP Residual norm 1.507157991448e-12 > > > Line search: gnorm after quadratic fit 5.809243699277e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.460487584142e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.893183483197e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.960337007072e+02 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.771527792790e+02 lambda=5.3912931685137378e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.150137639707e+02 lambda=5.3912931685137376e-04 > > > Line search: Cubically determined step, current gnorm 1.144964484571e+02 lambda=5.3912931685137380e-05 > > > 32 SNES Function norm 1.144964484571e+02 > > > 0 KSP Residual norm 3.859510930996e+01 > > > 1 KSP Residual norm 8.069118044382e-13 > > > Line search: gnorm after quadratic fit 1.106329930525e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.155884463041e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.933963819094e+02 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.849629797377e+02 lambda=9.7744286136270241e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.150857687050e+02 lambda=9.7744286136270254e-04 > > > Line search: Cubically determined step, current gnorm 1.144922906340e+02 lambda=9.7744286136270254e-05 > > > 33 SNES Function norm 1.144922906340e+02 > > > 0 KSP Residual norm 4.952038022394e+01 > > > 1 KSP Residual norm 7.460263245424e-13 > > > Line search: gnorm after quadratic fit 3.005091127220e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.229308416025e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.138600794682e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.390856262238e+02 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.394997214983e+02 lambda=4.4582997750629580e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.146836358799e+02 lambda=4.4582997750629581e-04 > > > Line search: Cubically determined step, current gnorm 1.144895966587e+02 lambda=4.7644082443915877e-05 > > > 34 SNES Function norm 1.144895966587e+02 > > > 0 KSP Residual norm 1.146914786457e+02 > > > 1 KSP Residual norm 4.791627042400e-12 > > > Line search: gnorm after quadratic fit 2.601294145944e+05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.324148513778e+04 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.247478406023e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.200340900661e+03 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.696223112300e+02 lambda=6.1514413845115794e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.342365431983e+02 lambda=1.7502929694284564e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.146686063035e+02 lambda=1.7502929694284566e-04 > > > Line search: Cubically determined step, current gnorm 1.144895868489e+02 lambda=1.7502929694284566e-05 > > > 35 SNES Function norm 1.144895868489e+02 > > > 0 KSP Residual norm 6.311017209658e+01 > > > 1 KSP Residual norm 8.384445939117e-13 > > > Line search: gnorm after quadratic fit 5.781533400572e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.419557746031e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.886081770030e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.945810143740e+02 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.767820854837e+02 lambda=5.3859001959289735e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.150034040559e+02 lambda=5.3859001959289732e-04 > > > Line search: Cubically determined step, current gnorm 1.144891501665e+02 lambda=5.3859001959289732e-05 > > > 36 SNES Function norm 1.144891501665e+02 > > > 0 KSP Residual norm 3.880748384332e+01 > > > 1 KSP Residual norm 6.400339290453e-13 > > > Line search: gnorm after quadratic fit 1.122504184426e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.180728237366e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.987870621566e+02 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.863711604331e+02 lambda=9.8150771384688824e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.150916783781e+02 lambda=9.8150771384688824e-04 > > > Line search: Cubically determined step, current gnorm 1.144850837411e+02 lambda=9.8150771384688832e-05 > > > 37 SNES Function norm 1.144850837411e+02 > > > 0 KSP Residual norm 4.811537498557e+01 > > > 1 KSP Residual norm 9.738167670242e-13 > > > Line search: gnorm after quadratic fit 2.784098355218e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.885118868254e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.074843354348e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.255202820836e+02 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.365202996130e+02 lambda=4.3204204582016374e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.146504919412e+02 lambda=4.3204204582016374e-04 > > > Line search: Cubically determined step, current gnorm 1.144822306241e+02 lambda=5.0376546850227848e-05 > > > 38 SNES Function norm 1.144822306241e+02 > > > 0 KSP Residual norm 1.120914002482e+02 > > > 1 KSP Residual norm 5.452125292284e-12 > > > Line search: gnorm after quadratic fit 2.427186680567e+05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.112196656857e+04 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.967397366072e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.149551659770e+03 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.529630886791e+02 lambda=6.0885216927030559e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.315267519231e+02 lambda=1.6656233536183130e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.146353659250e+02 lambda=1.6656233536183130e-04 > > > Line search: Cubically determined step, current gnorm 1.144820487391e+02 lambda=1.6656233536183130e-05 > > > 39 SNES Function norm 1.144820487391e+02 > > > 0 KSP Residual norm 7.182416170980e+01 > > > 1 KSP Residual norm 1.292147133333e-12 > > > Line search: gnorm after quadratic fit 8.255331293322e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.302939895170e+04 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.501228089911e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.185010378583e+02 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.088179821424e+02 lambda=5.7489510178867142e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.168272901121e+02 lambda=9.7452649444612811e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144951972300e+02 lambda=9.7452649444612822e-05 > > > Line search: Cubically determined step, current gnorm 1.144807676687e+02 lambda=2.2399506502463798e-05 > > > 40 SNES Function norm 1.144807676687e+02 > > > 0 KSP Residual norm 1.728679810285e+02 > > > 1 KSP Residual norm 3.878068639716e-12 > > > Line search: gnorm after quadratic fit 9.011020578535e+05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.111818830011e+05 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.504789858103e+04 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.754312133162e+03 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.212492111975e+02 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.199969180537e+02 lambda=2.6424184504193135e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.154794639440e+02 lambda=2.6424184504193136e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144880673342e+02 lambda=2.6424184504193136e-05 > > > Line search: Cubically determined step, current gnorm 1.144805461570e+02 lambda=3.8712107591125690e-06 > > > 41 SNES Function norm 1.144805461570e+02 > > > 0 KSP Residual norm 4.162780846202e+02 > > > 1 KSP Residual norm 1.732341544934e-11 > > > Line search: gnorm after quadratic fit 1.355673864369e+07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.747523002884e+06 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.342205048417e+05 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.425635699680e+04 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.882150659178e+03 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.259664786336e+03 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.653670676209e+02 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.453655830144e+02 lambda=5.8237455565260388e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.147659525018e+02 lambda=5.8237455565260393e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144827915995e+02 lambda=5.8237455565260400e-06 > > > Line search: Cubically determined step, current gnorm 1.144805080017e+02 lambda=6.6689295146509104e-07 > > > 42 SNES Function norm 1.144805080017e+02 > > > 0 KSP Residual norm 1.004135512581e+03 > > > 1 KSP Residual norm 3.867626041000e-09 > > > Line search: gnorm after quadratic fit 1.832578994882e+08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.269698278878e+07 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.792476589915e+06 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.420660371083e+05 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.321686926168e+04 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.548358078234e+03 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.429504802276e+03 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.317723385004e+02 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.460079723095e+02 lambda=2.5078917343692407e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.147908977725e+02 lambda=2.5078917343692408e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144833604238e+02 lambda=2.5078917343692412e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144805106824e+02 lambda=2.5078917343692411e-07 > > > Line search: Cubically determined step, current gnorm 1.144805014337e+02 lambda=1.1468707119027746e-07 > > > 43 SNES Function norm 1.144805014337e+02 > > > 0 KSP Residual norm 2.418614573592e+03 > > > 1 KSP Residual norm 6.085078742847e-10 > > > Line search: gnorm after quadratic fit 2.598476259775e+09 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.262759415873e+08 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.116845970403e+07 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.250465130250e+06 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.863493884574e+05 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.501468163771e+04 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.482658980483e+04 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.802395557883e+03 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.788149582374e+02 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.248828337038e+02 lambda=1.8333058767960295e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.186285836222e+02 lambda=3.7550993478654105e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.145209710139e+02 lambda=3.7550993478654107e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144808670668e+02 lambda=3.7550993478654111e-07 > > > Line search: Cubically determined step, current gnorm 1.144805012252e+02 lambda=3.7550993478654114e-08 > > > 44 SNES Function norm 1.144805012252e+02 > > > 0 KSP Residual norm 1.432476672735e+03 > > > 1 KSP Residual norm 7.850524783892e-11 > > > Line search: gnorm after quadratic fit 5.336191593632e+08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.625576866625e+07 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.181408387845e+06 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.003310644422e+06 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.236384273292e+05 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.658430638069e+04 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.977463068161e+03 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.674238499253e+02 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.333616820791e+02 lambda=3.3764776729281175e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.161349153752e+02 lambda=4.0497161764116874e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144966925969e+02 lambda=4.0497161764116874e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144806214839e+02 lambda=4.0497161764116878e-07 > > > Line search: Cubically determined step, current gnorm 1.144804979966e+02 lambda=5.6339112427782378e-08 > > > 45 SNES Function norm 1.144804979966e+02 > > > 0 KSP Residual norm 3.453401579761e+03 > > > 1 KSP Residual norm 4.197968028126e-09 > > > Line search: gnorm after quadratic fit 7.554006183767e+09 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.471974940372e+08 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.191613865049e+08 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.509784334249e+07 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.943752478560e+06 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.597601716755e+05 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.775572331075e+04 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.418045407608e+03 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.357066758731e+03 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.859267839080e+02 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.501494912160e+02 lambda=7.5160826909319168e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.148144926477e+02 lambda=7.5160826909319171e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144837498478e+02 lambda=7.5160826909319179e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144805227746e+02 lambda=7.5160826909319182e-08 > > > Line search: Cubically determined step, current gnorm 1.144804974438e+02 lambda=9.6864021663644795e-09 > > > 46 SNES Function norm 1.144804974438e+02 > > > 0 KSP Residual norm 8.345139428850e+03 > > > 1 KSP Residual norm 1.027819754739e-09 > > > Line search: gnorm after quadratic fit 1.061319903906e+11 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.325012985379e+10 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.652236226640e+09 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.055533971630e+08 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.546607716763e+07 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.134442858835e+06 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.839168570687e+05 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.830568178626e+04 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.201776786081e+03 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.540520468013e+03 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.573504890506e+02 lambda=9.7656250000000005e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.516203908013e+02 lambda=3.2703670177372021e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.148480075676e+02 lambda=3.2703670177372022e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144841475328e+02 lambda=3.2703670177372023e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144805305720e+02 lambda=3.2703670177372021e-08 > > > Line search: Cubically determined step, current gnorm 1.144804974367e+02 lambda=3.2703670177372025e-09 > > > 47 SNES Function norm 1.144804974367e+02 > > > 0 KSP Residual norm 4.668983500382e+03 > > > 1 KSP Residual norm 1.398997665317e-09 > > > Line search: gnorm after quadratic fit 1.865309565532e+10 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.336975299727e+09 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.934905088739e+08 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.704520478641e+07 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.728477809448e+06 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.193001670096e+05 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.610673238239e+04 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.354711683605e+04 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.589557246433e+03 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.367851970709e+02 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.136930269795e+02 lambda=9.0316845802227864e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.172186635069e+02 lambda=1.5831613287181393e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.145074017254e+02 lambda=1.5831613287181394e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144807499816e+02 lambda=1.5831613287181396e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144804983345e+02 lambda=1.5831613287181397e-08 > > > Line search: Cubically determined step, current gnorm 1.144804971346e+02 lambda=5.2932921109871310e-09 > > > 48 SNES Function norm 1.144804971346e+02 > > > 0 KSP Residual norm 1.132678078317e+04 > > > 1 KSP Residual norm 2.477518733314e-10 > > > Line search: gnorm after quadratic fit 2.654659022365e+11 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.315296223725e+10 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.136635677074e+09 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.152507060235e+08 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.397060094478e+07 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.898362012287e+06 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.685179520906e+05 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.194040779842e+05 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.606415730227e+04 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.902698091972e+03 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.521549384652e+02 lambda=9.7656250000000005e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.288999778994e+02 lambda=4.1899746703195281e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.157880829786e+02 lambda=4.5470218451893824e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144935741206e+02 lambda=4.5470218451893828e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144806232638e+02 lambda=4.5470218451893831e-08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144804979250e+02 lambda=4.5470218451893835e-09 > > > Line search: Cubically determined step, current gnorm 1.144804970825e+02 lambda=9.0293679903918216e-10 > > > 49 SNES Function norm 1.144804970825e+02 > > > 0 KSP Residual norm 2.712544829144e+04 > > > 1 KSP Residual norm 4.949246309677e-09 > > > Line search: gnorm after quadratic fit 3.650846005745e+12 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.565321055911e+11 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.711080201118e+10 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.150022242308e+09 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.965954117985e+08 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.128096393645e+08 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.429702091584e+07 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.841819946536e+06 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.465032956946e+05 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.594210253794e+04 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.141110278944e+03 lambda=9.7656250000000005e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.306952279045e+03 lambda=4.8828125000000003e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.754164864338e+02 lambda=2.4414062500000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.476861367158e+02 lambda=9.2451761406722810e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.147929263780e+02 lambda=9.2451761406722810e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144836022952e+02 lambda=9.2451761406722821e-08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144805271860e+02 lambda=9.2451761406722831e-09 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144804972895e+02 lambda=9.2451761406722839e-10 > > > Line search: Cubically determined step, current gnorm 1.144804970737e+02 lambda=1.5633616333063305e-10 > > > 50 SNES Function norm 1.144804970737e+02 > > > 0 SNES Function norm 2.308693894796e+03 > > > 0 KSP Residual norm 8.981999720532e+00 > > > 1 KSP Residual norm 2.363170936183e-13 > > > Line search: Using full step: fnorm 2.308693894796e+03 gnorm 7.571661187318e+02 > > > 1 SNES Function norm 7.571661187318e+02 > > > 0 KSP Residual norm 2.149614048903e+00 > > > 1 KSP Residual norm 9.511247057888e-13 > > > Line search: Using full step: fnorm 7.571661187318e+02 gnorm 4.450081004997e+02 > > > 2 SNES Function norm 4.450081004997e+02 > > > 0 KSP Residual norm 1.706469075123e+01 > > > 1 KSP Residual norm 5.803815175472e-13 > > > Line search: gnorm after quadratic fit 1.510518198899e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.850796532980e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.515983139755e+02 lambda=2.0602556887689423e-02 > > > Line search: Cubically determined step, current gnorm 4.434800867235e+02 lambda=8.2396279492937211e-03 > > > 3 SNES Function norm 4.434800867235e+02 > > > 0 KSP Residual norm 3.208587171626e+00 > > > 1 KSP Residual norm 1.099072610659e-13 > > > Line search: gnorm after quadratic fit 4.080637194736e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 4 SNES Function norm 4.080637194736e+02 > > > 0 KSP Residual norm 8.136557176540e+00 > > > 1 KSP Residual norm 8.800137844173e-13 > > > Line search: gnorm after quadratic fit 5.261656549654e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.131114070934e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 4.031614746044e+02 lambda=2.4674842039461482e-02 > > > 5 SNES Function norm 4.031614746044e+02 > > > 0 KSP Residual norm 7.609918907567e+00 > > > 1 KSP Residual norm 1.613159932655e-13 > > > Line search: gnorm after quadratic fit 5.353908064984e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.110480554132e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 3.991168240716e+02 lambda=2.3079500036735322e-02 > > > 6 SNES Function norm 3.991168240716e+02 > > > 0 KSP Residual norm 3.800845472041e+00 > > > 1 KSP Residual norm 4.841682188278e-13 > > > Line search: gnorm after quadratic fit 3.787886582952e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 7 SNES Function norm 3.787886582952e+02 > > > 0 KSP Residual norm 1.892621919219e+00 > > > 1 KSP Residual norm 3.576655371800e-12 > > > Line search: gnorm after quadratic fit 3.440181918909e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 8 SNES Function norm 3.440181918909e+02 > > > 0 KSP Residual norm 3.559759789147e+00 > > > 1 KSP Residual norm 8.347521826622e-13 > > > Line search: gnorm after quadratic fit 3.287993515195e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 9 SNES Function norm 3.287993515195e+02 > > > 0 KSP Residual norm 1.825073540507e+00 > > > 1 KSP Residual norm 8.352745008123e-14 > > > Line search: Using full step: fnorm 3.287993515195e+02 gnorm 2.710650507416e+02 > > > 10 SNES Function norm 2.710650507416e+02 > > > 0 KSP Residual norm 7.568432945608e-01 > > > 1 KSP Residual norm 2.780715252274e-14 > > > Line search: Using full step: fnorm 2.710650507416e+02 gnorm 1.513359047342e+02 > > > 11 SNES Function norm 1.513359047342e+02 > > > 0 KSP Residual norm 9.387460484575e+00 > > > 1 KSP Residual norm 7.091233040676e-13 > > > Line search: gnorm after quadratic fit 3.998857979851e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.060972049714e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.512140169420e+02 lambda=5.4338709720680610e-03 > > > 12 SNES Function norm 1.512140169420e+02 > > > 0 KSP Residual norm 4.399424360499e+00 > > > 1 KSP Residual norm 1.614362118182e-13 > > > Line search: gnorm after quadratic fit 1.913552832643e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.559719302467e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.499985374733e+02 lambda=1.7102027220313589e-02 > > > 13 SNES Function norm 1.499985374733e+02 > > > 0 KSP Residual norm 3.740397849742e+00 > > > 1 KSP Residual norm 8.986775577006e-13 > > > Line search: gnorm after quadratic fit 1.764118876632e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.522381536119e+02 lambda=4.8196830215713270e-02 > > > Line search: Cubically determined step, current gnorm 1.486175880390e+02 lambda=1.8881300948189364e-02 > > > 14 SNES Function norm 1.486175880390e+02 > > > 0 KSP Residual norm 6.067973818528e+00 > > > 1 KSP Residual norm 4.527845229549e-13 > > > Line search: gnorm after quadratic fit 2.514021299115e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.679972156573e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.481015724304e+02 lambda=9.0116621678703428e-03 > > > 15 SNES Function norm 1.481015724304e+02 > > > 0 KSP Residual norm 6.108754994263e+00 > > > 1 KSP Residual norm 2.557635976440e-13 > > > Line search: gnorm after quadratic fit 2.458081150104e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.681837029397e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.476148340442e+02 lambda=7.9580911933571953e-03 > > > 16 SNES Function norm 1.476148340442e+02 > > > 0 KSP Residual norm 7.914946163932e+00 > > > 1 KSP Residual norm 1.512066885699e-13 > > > Line search: gnorm after quadratic fit 3.458938604598e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.883018868359e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.474286108114e+02 lambda=6.7262521208543979e-03 > > > 17 SNES Function norm 1.474286108114e+02 > > > 0 KSP Residual norm 5.285449532689e+00 > > > 1 KSP Residual norm 6.693733977456e-12 > > > Line search: gnorm after quadratic fit 2.170263102661e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.607560548008e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.467785507822e+02 lambda=9.9244383205188240e-03 > > > 18 SNES Function norm 1.467785507822e+02 > > > 0 KSP Residual norm 8.124903695635e+00 > > > 1 KSP Residual norm 2.322439601127e-11 > > > Line search: gnorm after quadratic fit 3.589716592364e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.907315184877e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.466341888638e+02 lambda=6.5538271222582893e-03 > > > 19 SNES Function norm 1.466341888638e+02 > > > 0 KSP Residual norm 5.253550718343e+00 > > > 1 KSP Residual norm 1.575657996883e-12 > > > Line search: gnorm after quadratic fit 2.155795776725e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.598564001687e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.459869404602e+02 lambda=9.9195822632931301e-03 > > > 20 SNES Function norm 1.459869404602e+02 > > > 0 KSP Residual norm 8.405987790193e+00 > > > 1 KSP Residual norm 2.046159481178e-13 > > > Line search: gnorm after quadratic fit 3.767908298426e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.941885062002e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.458995232755e+02 lambda=6.4359684554015136e-03 > > > 21 SNES Function norm 1.458995232755e+02 > > > 0 KSP Residual norm 5.036348246593e+00 > > > 1 KSP Residual norm 3.645081669075e-13 > > > Line search: gnorm after quadratic fit 2.083222977519e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.575737508694e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.452039802458e+02 lambda=1.0554092389542354e-02 > > > 22 SNES Function norm 1.452039802458e+02 > > > 0 KSP Residual norm 8.562292355998e+00 > > > 1 KSP Residual norm 3.256332645483e-13 > > > Line search: gnorm after quadratic fit 3.869470823355e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.959483128249e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.451523830598e+02 lambda=6.3780526507799607e-03 > > > 23 SNES Function norm 1.451523830598e+02 > > > 0 KSP Residual norm 4.919667503862e+00 > > > 1 KSP Residual norm 4.823931177115e-13 > > > Line search: gnorm after quadratic fit 2.042891039525e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.560623102934e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.444331916523e+02 lambda=1.0890355421223689e-02 > > > 24 SNES Function norm 1.444331916523e+02 > > > 0 KSP Residual norm 8.727282395369e+00 > > > 1 KSP Residual norm 7.090683582186e-13 > > > Line search: gnorm after quadratic fit 3.977929422821e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.978556223200e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.444215965394e+02 lambda=6.3477766966048947e-03 > > > 25 SNES Function norm 1.444215965394e+02 > > > 0 KSP Residual norm 4.759732971179e+00 > > > 1 KSP Residual norm 7.539889498211e-13 > > > Line search: gnorm after quadratic fit 1.990589649135e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.542648241555e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.436629416941e+02 lambda=1.1434720389464151e-02 > > > 26 SNES Function norm 1.436629416941e+02 > > > 0 KSP Residual norm 8.844861828477e+00 > > > 1 KSP Residual norm 4.372001279689e-13 > > > Line search: gnorm after quadratic fit 4.055598972133e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.990820671396e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.436827663113e+02 lambda=6.3302081701296859e-03 > > > Line search: Cubically determined step, current gnorm 1.434397789472e+02 lambda=3.1285674619640730e-03 > > > 27 SNES Function norm 1.434397789472e+02 > > > 0 KSP Residual norm 2.168630760128e+01 > > > 1 KSP Residual norm 3.975838928402e-13 > > > Line search: gnorm after quadratic fit 1.655681371309e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.972331169594e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.804118272840e+02 lambda=1.6710557456633125e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.435928635079e+02 lambda=1.6710557456633126e-03 > > > Line search: Cubically determined step, current gnorm 1.434032742903e+02 lambda=5.1357350159978810e-04 > > > 28 SNES Function norm 1.434032742903e+02 > > > 0 KSP Residual norm 5.259508821923e+01 > > > 1 KSP Residual norm 1.358381204928e-11 > > > Line search: gnorm after quadratic fit 1.908330224731e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.431279702545e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.060945045253e+02 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.791318323447e+02 lambda=1.2124172979783788e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.491140019897e+02 lambda=2.6952165802905347e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434246250245e+02 lambda=2.6952165802905350e-04 > > > Line search: Cubically determined step, current gnorm 1.433970449422e+02 lambda=8.6980371578986910e-05 > > > 29 SNES Function norm 1.433970449422e+02 > > > 0 KSP Residual norm 1.326287161615e+02 > > > 1 KSP Residual norm 5.692176796134e-12 > > > Line search: gnorm after quadratic fit 2.077891749832e+05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.654187989332e+04 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.213029457851e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.001385334742e+03 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.323976827250e+02 lambda=5.9607661619885998e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.489839529892e+02 lambda=1.0476257410701045e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434396736634e+02 lambda=1.0476257410701046e-04 > > > Line search: Cubically determined step, current gnorm 1.433960671821e+02 lambda=1.3664867646895530e-05 > > > 30 SNES Function norm 1.433960671821e+02 > > > 0 KSP Residual norm 3.320710360189e+02 > > > 1 KSP Residual norm 1.365660123102e-11 > > > Line search: gnorm after quadratic fit 3.597335441013e+06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.714766420450e+05 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.566809766217e+04 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.038660363150e+04 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.026997416957e+03 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.382653551072e+02 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.071747386385e+02 lambda=1.3384948046761360e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.439693866777e+02 lambda=1.3384948046761360e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434000505249e+02 lambda=1.3384948046761361e-05 > > > Line search: Cubically determined step, current gnorm 1.433959111179e+02 lambda=2.1771867000079373e-06 > > > 31 SNES Function norm 1.433959111179e+02 > > > 0 KSP Residual norm 8.385024273664e+02 > > > 1 KSP Residual norm 2.688330817732e-11 > > > Line search: gnorm after quadratic fit 5.487352481970e+07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.776642694838e+06 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.310551423141e+05 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.023322644608e+05 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.368662233379e+04 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.472194884015e+03 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.718801059897e+02 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.274234972424e+02 lambda=6.3064412238487922e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.442194384053e+02 lambda=6.3064412238487925e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434033578642e+02 lambda=6.3064412238487927e-06 > > > Line search: Cubically determined step, current gnorm 1.433959042208e+02 lambda=6.3064412238487929e-07 > > > 32 SNES Function norm 1.433959042208e+02 > > > 0 KSP Residual norm 5.310191626867e+02 > > > 1 KSP Residual norm 2.270033897601e-10 > > > Line search: gnorm after quadratic fit 1.447633783740e+07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.859761774309e+06 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.472992503503e+05 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.557594026810e+04 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.969012939380e+03 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.269212161982e+03 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.859005100842e+02 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.695095262046e+02 lambda=5.4509037994531233e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.436389958907e+02 lambda=5.4509037994531237e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433976258223e+02 lambda=5.4509037994531242e-06 > > > Line search: Cubically determined step, current gnorm 1.433958431980e+02 lambda=8.5124820362933632e-07 > > > 33 SNES Function norm 1.433958431980e+02 > > > 0 KSP Residual norm 1.341142541825e+03 > > > 1 KSP Residual norm 4.194815344365e-11 > > > Line search: gnorm after quadratic fit 2.256410317099e+08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.797696259877e+07 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.447237377751e+06 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.221898175722e+05 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.260244723327e+04 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.539148524881e+03 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.558034531173e+03 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.788188892302e+02 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.753621043454e+02 lambda=2.4427125599600652e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.437122397600e+02 lambda=2.4427125599600654e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433986985128e+02 lambda=2.4427125599600655e-06 > > > Line search: Cubically determined step, current gnorm 1.433958402293e+02 lambda=2.4427125599600656e-07 > > > 34 SNES Function norm 1.433958402293e+02 > > > 0 KSP Residual norm 8.620962950418e+02 > > > 1 KSP Residual norm 4.517777375659e-11 > > > Line search: gnorm after quadratic fit 6.134442313460e+07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.790495969255e+06 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.008365220843e+06 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.364572513478e+05 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.037891335918e+04 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.640571521199e+03 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.472549649319e+02 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.906041216274e+02 lambda=7.6348458761785112e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.504925859329e+02 lambda=1.7740973415567094e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434632637071e+02 lambda=1.7740973415567094e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433962847027e+02 lambda=1.7740973415567095e-06 > > > Line search: Cubically determined step, current gnorm 1.433958170795e+02 lambda=3.2293255704969003e-07 > > > 35 SNES Function norm 1.433958170795e+02 > > > 0 KSP Residual norm 2.177497039945e+03 > > > 1 KSP Residual norm 8.546235181505e-11 > > > Line search: gnorm after quadratic fit 9.689178330938e+08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.204850731541e+08 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.491460480376e+07 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.833699292784e+06 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.246639021599e+05 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.860166571872e+04 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.484329051490e+03 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.050411687443e+03 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.488366972009e+02 lambda=3.7767265396089055e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.508326035050e+02 lambda=7.2725649346261757e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434696063559e+02 lambda=7.2725649346261764e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433964618996e+02 lambda=7.2725649346261768e-07 > > > Line search: Cubically determined step, current gnorm 1.433958141405e+02 lambda=7.2725649346261771e-08 > > > 36 SNES Function norm 1.433958141405e+02 > > > 0 KSP Residual norm 2.164813477994e+03 > > > 1 KSP Residual norm 1.148881458292e-10 > > > Line search: gnorm after quadratic fit 9.626940870744e+08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.210459267934e+08 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.531855101756e+07 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.966826097072e+06 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.611808255272e+05 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.746062783262e+04 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.252259871244e+03 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.319447372021e+03 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.963055448218e+02 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.719034797105e+02 lambda=1.3935000445038475e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.436664111092e+02 lambda=1.3935000445038476e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433983336239e+02 lambda=1.3935000445038476e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958213497e+02 lambda=1.3935000445038476e-07 > > > Line search: Cubically determined step, current gnorm 1.433958104705e+02 lambda=5.1202466521517630e-08 > > > 37 SNES Function norm 1.433958104705e+02 > > > 0 KSP Residual norm 5.470482746849e+03 > > > 1 KSP Residual norm 2.077456833170e-10 > > > Line search: gnorm after quadratic fit 1.541335606193e+10 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.922526157954e+09 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.393079394383e+08 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.967573549050e+07 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.657319925168e+06 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.479516204895e+05 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.573399122917e+04 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.931177424479e+03 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.619710606187e+03 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.924551713717e+02 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.786095404459e+02 lambda=6.2808469554243522e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.437467476469e+02 lambda=6.2808469554243527e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433992463439e+02 lambda=6.2808469554243527e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958367271e+02 lambda=6.2808469554243525e-08 > > > Line search: Cubically determined step, current gnorm 1.433958098948e+02 lambda=8.0208105170108588e-09 > > > 38 SNES Function norm 1.433958098948e+02 > > > 0 KSP Residual norm 1.380568582849e+04 > > > 1 KSP Residual norm 3.830866223513e-10 > > > Line search: gnorm after quadratic fit 2.484973518314e+11 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.108953896984e+10 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.893104137528e+09 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.884003910853e+08 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.150765563542e+07 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.811161146103e+06 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.011017986781e+06 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.368084343451e+05 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.042876665700e+04 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.648735196752e+03 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.489051252413e+02 lambda=9.7656250000000005e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.910677756717e+02 lambda=4.7728537787817724e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.505452645186e+02 lambda=1.1099980464343249e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434658984864e+02 lambda=1.1099980464343249e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433964956476e+02 lambda=1.1099980464343249e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958153212e+02 lambda=1.1099980464343250e-08 > > > Line search: Cubically determined step, current gnorm 1.433958098048e+02 lambda=1.2587012037197021e-09 > > > 39 SNES Function norm 1.433958098048e+02 > > > 0 KSP Residual norm 3.492284741552e+04 > > > 1 KSP Residual norm 2.459788921244e-09 > > > Line search: gnorm after quadratic fit 4.017424324975e+12 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.020053801097e+11 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.270768402853e+10 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.827801904036e+09 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.758550488105e+08 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.213492627852e+08 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.502191365805e+07 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.846947104704e+06 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.262850216093e+05 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.879926646684e+04 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.510203332079e+03 lambda=9.7656250000000005e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.055028679619e+03 lambda=4.8828125000000003e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.503903269554e+02 lambda=2.3633949212111800e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.510245991472e+02 lambda=4.5897967908360529e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434724062782e+02 lambda=4.5897967908360533e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433965706606e+02 lambda=4.5897967908360533e-08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958168196e+02 lambda=4.5897967908360538e-09 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958098155e+02 lambda=4.5897967908360540e-10 > > > Line search: Cubically determined step, current gnorm 1.433958097906e+02 lambda=1.9745369723997599e-10 > > > 40 SNES Function norm 1.433958097906e+02 > > > 0 KSP Residual norm 8.722495521587e+04 > > > 1 KSP Residual norm 3.742695919275e-09 > > > Line search: gnorm after quadratic fit 6.262538457180e+13 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.829256308992e+12 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.789282877890e+11 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.224340679566e+11 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.532137613500e+10 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.919506047737e+09 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.410488718338e+08 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.042211373104e+07 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.881986305609e+06 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.080857001861e+05 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.054449734307e+04 lambda=9.7656250000000005e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.109051581397e+04 lambda=4.8828125000000003e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.144985497099e+03 lambda=2.4414062500000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.617627947761e+02 lambda=1.2207031250000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.132828960986e+02 lambda=5.3137869181552773e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.440403409760e+02 lambda=5.3137869181552777e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434022226216e+02 lambda=5.3137869181552781e-08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958732177e+02 lambda=5.3137869181552781e-09 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958103569e+02 lambda=5.3137869181552779e-10 > > > Line search: Cubically determined step, current gnorm 1.433958097894e+02 lambda=5.3137869181552781e-11 > > > 41 SNES Function norm 1.433958097894e+02 > > > 0 KSP Residual norm 6.453169081212e+04 > > > 1 KSP Residual norm 2.762540688686e-09 > > > Line search: gnorm after quadratic fit 2.535166112592e+13 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.168366990040e+12 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.958985371462e+11 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.945064622488e+10 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.172244865713e+09 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.693002384290e+08 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.562568994785e+07 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.182957296890e+07 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.453260254263e+06 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.781984147743e+05 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.294934468515e+04 lambda=9.7656250000000005e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.740461720782e+03 lambda=4.8828125000000003e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.162621855154e+02 lambda=2.4414062500000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.042417294890e+02 lambda=1.1290474210136388e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.458920680477e+02 lambda=1.4201366604660443e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434208620254e+02 lambda=1.4201366604660444e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433960586269e+02 lambda=1.4201366604660445e-08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958120934e+02 lambda=1.4201366604660445e-09 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958097940e+02 lambda=1.4201366604660446e-10 > > > Line search: Cubically determined step, current gnorm 1.433958097852e+02 lambda=5.7981795207229486e-11 > > > 42 SNES Function norm 1.433958097852e+02 > > > 0 KSP Residual norm 1.596625793747e+05 > > > 1 KSP Residual norm 6.465899717071e-09 > > > Line search: gnorm after quadratic fit 3.840699863976e+14 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.801237514773e+13 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.002454410823e+12 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.505340831651e+11 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.387378188418e+10 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.174857842415e+10 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.472211181784e+09 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.849608933788e+08 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.336592011613e+07 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.988079805895e+06 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.930858080425e+05 lambda=9.7656250000000005e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.521190722497e+04 lambda=4.8828125000000003e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.872153015323e+03 lambda=2.4414062500000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.772337662956e+03 lambda=1.2207031250000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.879470852054e+02 lambda=6.1035156250000003e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.942774855488e+02 lambda=2.4957912736226801e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.438719078958e+02 lambda=2.4957912736226800e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434005516391e+02 lambda=2.4957912736226800e-08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958568732e+02 lambda=2.4957912736226803e-09 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958102244e+02 lambda=2.4957912736226804e-10 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958097865e+02 lambda=2.4957912736226805e-11 > > > Line search: Cubically determined step, current gnorm 1.433958097846e+02 lambda=9.2900433293108317e-12 > > > 43 SNES Function norm 1.433958097846e+02 > > > 0 KSP Residual norm 4.230869747157e+05 > > > 1 KSP Residual norm 2.238707423027e-08 > > > Line search: gnorm after quadratic fit 7.145700515048e+15 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.931871281700e+14 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.116420341041e+14 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.395366610168e+13 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.743811756566e+12 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.178776103292e+11 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.721012032848e+10 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.395186924428e+09 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.229125978585e+08 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.250971135953e+07 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.483856203094e+06 lambda=9.7656250000000005e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.950671355228e+05 lambda=4.8828125000000003e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.795408218555e+04 lambda=2.4414062500000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.315025696280e+04 lambda=1.2207031250000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.395961070555e+03 lambda=6.1035156250000003e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.565070307576e+02 lambda=3.0517578125000002e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.228949713871e+02 lambda=1.2154989071946628e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.441831998014e+02 lambda=1.2154989071946629e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434037055996e+02 lambda=1.2154989071946630e-08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958886074e+02 lambda=1.2154989071946630e-09 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958105564e+02 lambda=1.2154989071946630e-10 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958097907e+02 lambda=1.2154989071946631e-11 > > > Line search: Cubically determined step, current gnorm 1.433958097845e+02 lambda=1.3559489351735629e-12 > > > 44 SNES Function norm 1.433958097845e+02 > > > 0 KSP Residual norm 1.017589039922e+06 > > > 1 KSP Residual norm 5.483283808994e-08 > > > Line search: gnorm after quadratic fit 9.942386816509e+16 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.242813073279e+16 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.553553149772e+15 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.942033483320e+14 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.427772097758e+13 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.035291372732e+12 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.795558047824e+11 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.748073147307e+10 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.944235240368e+09 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.453550734860e+08 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.377045707707e+07 lambda=9.7656250000000005e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.188119937132e+07 lambda=4.8828125000000003e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.529730353136e+06 lambda=2.4414062500000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.044646611329e+05 lambda=1.2207031250000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.974477616118e+04 lambda=6.1035156250000003e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.087923877078e+03 lambda=3.0517578125000002e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.112257173311e+03 lambda=1.5258789062500001e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.536190077033e+02 lambda=7.6293945312500004e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.622567424729e+02 lambda=2.4244966960965791e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.435780438142e+02 lambda=2.4244966960965793e-08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433976282603e+02 lambda=2.4244966960965796e-09 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958279382e+02 lambda=2.4244966960965797e-10 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958099632e+02 lambda=2.4244966960965799e-11 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958097860e+02 lambda=2.4244966960965801e-12 > > > Line search: Cubically determined step, current gnorm 1.433958097845e+02 lambda=2.4244966960965801e-13 > > > 45 SNES Function norm 1.433958097845e+02 > > > 0 KSP Residual norm 2.206687220910e+06 > > > 1 KSP Residual norm 4.897651438902e-08 > > > Line search: gnorm after quadratic fit 1.013883843512e+18 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.267347883019e+17 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.584167551460e+16 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.980166189110e+15 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.475099638694e+14 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.093604443378e+13 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.866330988164e+12 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.831230804145e+11 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.034848618023e+10 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.533173457427e+09 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.390937545910e+08 lambda=9.7656250000000005e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.167706366282e+08 lambda=4.8828125000000003e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.445357932595e+07 lambda=2.4414062500000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.776833600920e+06 lambda=1.2207031250000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.177171496134e+05 lambda=6.1035156250000003e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.775750596740e+04 lambda=3.0517578125000002e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.374283858049e+03 lambda=1.5258789062500001e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.030949543491e+03 lambda=7.6293945312500004e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.423064811256e+02 lambda=3.6673216108643130e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.499924205417e+02 lambda=6.7541706529544844e-08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434620968378e+02 lambda=6.7541706529544851e-09 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433964732224e+02 lambda=6.7541706529544853e-10 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958164087e+02 lambda=6.7541706529544856e-11 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958098496e+02 lambda=6.7541706529544860e-12 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958097850e+02 lambda=6.7541706529544869e-13 > > > Line search: unable to find good step length! After 24 tries > > > Line search: fnorm=1.4339580978447020e+02, gnorm=1.4339580978501337e+02, ynorm=2.2066872446260620e+06, minlambda=9.9999999999999998e-13, lambda=6.7541706529544869e-13, initial slope=-2.0562359199040133e+04 > > > 0 SNES Function norm 7.494832241120e+03 > > > 0 KSP Residual norm 2.096735360816e+01 > > > 1 KSP Residual norm 1.310027756820e-12 > > > Line search: gnorm after quadratic fit 6.728375857515e+03 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 1 SNES Function norm 6.728375857515e+03 > > > 0 KSP Residual norm 2.051806116405e+01 > > > 1 KSP Residual norm 4.624620138831e-13 > > > Line search: gnorm after quadratic fit 6.028616261650e+03 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 2 SNES Function norm 6.028616261650e+03 > > > 0 KSP Residual norm 2.416503160016e+01 > > > 1 KSP Residual norm 8.456041680630e-13 > > > Line search: gnorm after quadratic fit 5.407473517447e+03 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 3 SNES Function norm 5.407473517447e+03 > > > 0 KSP Residual norm 1.429873750399e+01 > > > 1 KSP Residual norm 2.956316145819e-13 > > > Line search: Using full step: fnorm 5.407473517447e+03 gnorm 1.894530516076e+03 > > > 4 SNES Function norm 1.894530516076e+03 > > > 0 KSP Residual norm 2.898580554597e+00 > > > 1 KSP Residual norm 6.622560162623e-14 > > > Line search: Using full step: fnorm 1.894530516076e+03 gnorm 1.794029421846e+03 > > > 5 SNES Function norm 1.794029421846e+03 > > > 0 KSP Residual norm 1.749678611959e+01 > > > 1 KSP Residual norm 8.138905825078e-12 > > > Line search: gnorm after quadratic fit 1.767361408940e+03 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 6 SNES Function norm 1.767361408940e+03 > > > 0 KSP Residual norm 1.094404109423e+02 > > > 1 KSP Residual norm 7.696691527700e-12 > > > Line search: gnorm after quadratic fit 3.545750923895e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.153479540314e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.205683629874e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.802976525485e+03 lambda=1.2441094586006883e-02 > > > Line search: Cubically determined step, current gnorm 1.765063299263e+03 lambda=4.9240328094708914e-03 > > > 7 SNES Function norm 1.765063299263e+03 > > > 0 KSP Residual norm 1.778095975189e+01 > > > 1 KSP Residual norm 2.814661813934e-12 > > > Line search: gnorm after quadratic fit 2.620761680117e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.793045753271e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.740299227935e+03 lambda=2.5000000000000001e-02 > > > 8 SNES Function norm 1.740299227935e+03 > > > 0 KSP Residual norm 3.284236894535e+02 > > > 1 KSP Residual norm 5.172103783952e-10 > > > Line search: gnorm after quadratic fit 2.857820523902e+05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.063993491139e+04 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.588139591650e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.491163684413e+03 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.802614760566e+03 lambda=5.7977212395253904e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.741444490992e+03 lambda=1.8448315876950813e-03 > > > Line search: Cubically determined step, current gnorm 1.739663656043e+03 lambda=7.7468345598227730e-04 > > > 9 SNES Function norm 1.739663656043e+03 > > > 0 KSP Residual norm 4.581839103558e+02 > > > 1 KSP Residual norm 2.627035885943e-11 > > > Line search: gnorm after quadratic fit 8.199478499066e+05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.127270076812e+05 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.816774161281e+04 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.053723877333e+03 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.971814513392e+03 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.755066208174e+03 lambda=2.7232010924558834e-03 > > > Line search: Cubically determined step, current gnorm 1.739559834479e+03 lambda=8.1458417855297680e-04 > > > 10 SNES Function norm 1.739559834479e+03 > > > 0 KSP Residual norm 1.463056810139e+02 > > > 1 KSP Residual norm 5.383584598825e-12 > > > Line search: gnorm after quadratic fit 2.885699620595e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.847717401708e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.244464170034e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.769157604338e+03 lambda=1.0857209099577540e-02 > > > Line search: Cubically determined step, current gnorm 1.737356225452e+03 lambda=4.0312937622950231e-03 > > > 11 SNES Function norm 1.737356225452e+03 > > > 0 KSP Residual norm 1.564105677925e+02 > > > 1 KSP Residual norm 6.671164745832e-11 > > > Line search: gnorm after quadratic fit 3.815800291873e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.197027796134e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.373151605545e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.783976520867e+03 lambda=1.2093374970461970e-02 > > > Line search: Cubically determined step, current gnorm 1.735737929915e+03 lambda=4.9529698477569920e-03 > > > 12 SNES Function norm 1.735737929915e+03 > > > 0 KSP Residual norm 5.030757139645e+01 > > > 1 KSP Residual norm 1.157542730692e-12 > > > Line search: gnorm after quadratic fit 3.004544441458e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.850403239750e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.722893188305e+03 lambda=2.0881992439921702e-02 > > > 13 SNES Function norm 1.722893188305e+03 > > > 0 KSP Residual norm 7.123428853845e+01 > > > 1 KSP Residual norm 8.671726774894e-12 > > > Line search: gnorm after quadratic fit 4.361041499279e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.032697222107e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.726212330814e+03 lambda=1.9909470348267504e-02 > > > Line search: Cubically determined step, current gnorm 1.714127356920e+03 lambda=9.9547351741337518e-03 > > > 14 SNES Function norm 1.714127356920e+03 > > > 0 KSP Residual norm 8.304557447257e+00 > > > 1 KSP Residual norm 6.268295862688e-13 > > > Line search: gnorm after quadratic fit 1.558163002487e+03 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 15 SNES Function norm 1.558163002487e+03 > > > 0 KSP Residual norm 2.820803287164e+00 > > > 1 KSP Residual norm 5.477413853752e-13 > > > Line search: gnorm after quadratic fit 1.065673478530e+03 > > > Line search: Quadratically determined step, lambda=3.8943438938591052e-01 > > > 16 SNES Function norm 1.065673478530e+03 > > > 0 KSP Residual norm 2.296739120664e+00 > > > 1 KSP Residual norm 6.273731899885e-14 > > > Line search: gnorm after quadratic fit 8.964342150621e+02 > > > Line search: Quadratically determined step, lambda=1.8740736900935545e-01 > > > 17 SNES Function norm 8.964342150621e+02 > > > 0 KSP Residual norm 5.567568505830e+00 > > > 1 KSP Residual norm 8.649083600764e-12 > > > Line search: gnorm after quadratic fit 8.322514858992e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 18 SNES Function norm 8.322514858992e+02 > > > 0 KSP Residual norm 1.164393577210e+00 > > > 1 KSP Residual norm 2.019248309015e-14 > > > Line search: Using full step: fnorm 8.322514858992e+02 gnorm 3.179750274746e+02 > > > 19 SNES Function norm 3.179750274746e+02 > > > 0 KSP Residual norm 5.339294310641e+00 > > > 1 KSP Residual norm 2.070321587238e-13 > > > Line search: gnorm after quadratic fit 3.433012316833e+02 > > > Line search: Cubically determined step, current gnorm 3.140305403821e+02 lambda=5.0000000000000003e-02 > > > 20 SNES Function norm 3.140305403821e+02 > > > 0 KSP Residual norm 1.177016565578e+01 > > > 1 KSP Residual norm 2.413027540446e-13 > > > Line search: gnorm after quadratic fit 7.377851778409e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.896721016582e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 3.136619309181e+02 lambda=9.7219892278716195e-03 > > > 21 SNES Function norm 3.136619309181e+02 > > > 0 KSP Residual norm 3.973565083977e+00 > > > 1 KSP Residual norm 9.726786674410e-14 > > > Line search: gnorm after quadratic fit 3.098277326090e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 22 SNES Function norm 3.098277326090e+02 > > > 0 KSP Residual norm 9.389290683519e+00 > > > 1 KSP Residual norm 1.651497163724e-13 > > > Line search: gnorm after quadratic fit 6.887970540455e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.588146381477e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.099274823603e+02 lambda=1.6890426151283184e-02 > > > Line search: Cubically determined step, current gnorm 3.084890760827e+02 lambda=8.4452130756415920e-03 > > > 23 SNES Function norm 3.084890760827e+02 > > > 0 KSP Residual norm 2.381130479641e+00 > > > 1 KSP Residual norm 4.694489283156e-14 > > > Line search: gnorm after quadratic fit 2.872151876535e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 24 SNES Function norm 2.872151876535e+02 > > > 0 KSP Residual norm 2.405498502269e+00 > > > 1 KSP Residual norm 3.316846070538e-13 > > > Line search: gnorm after quadratic fit 2.686789761232e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 25 SNES Function norm 2.686789761232e+02 > > > 0 KSP Residual norm 1.728772970554e+00 > > > 1 KSP Residual norm 4.132974383339e-14 > > > Line search: gnorm after quadratic fit 2.365009918229e+02 > > > Line search: Quadratically determined step, lambda=1.7273357529379074e-01 > > > 26 SNES Function norm 2.365009918229e+02 > > > 0 KSP Residual norm 4.413764759374e+00 > > > 1 KSP Residual norm 5.210690816917e-14 > > > Line search: gnorm after quadratic fit 2.756730968257e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.372321757171e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 2.335020811250e+02 lambda=2.5000000000000001e-02 > > > 27 SNES Function norm 2.335020811250e+02 > > > 0 KSP Residual norm 1.606246507553e+00 > > > 1 KSP Residual norm 3.564847846678e-14 > > > Line search: gnorm after quadratic fit 2.078263630653e+02 > > > Line search: Quadratically determined step, lambda=1.5913860995949433e-01 > > > 28 SNES Function norm 2.078263630653e+02 > > > 0 KSP Residual norm 3.700632954873e+00 > > > 1 KSP Residual norm 5.113863400264e-13 > > > Line search: gnorm after quadratic fit 2.142503514807e+02 > > > Line search: Cubically determined step, current gnorm 2.021095009118e+02 lambda=5.0000000000000003e-02 > > > 29 SNES Function norm 2.021095009118e+02 > > > 0 KSP Residual norm 3.056449560135e+00 > > > 1 KSP Residual norm 3.207987681334e-14 > > > Line search: gnorm after quadratic fit 2.064252530802e+02 > > > Line search: Cubically determined step, current gnorm 1.978069081639e+02 lambda=5.0000000000000003e-02 > > > 30 SNES Function norm 1.978069081639e+02 > > > 0 KSP Residual norm 2.024695620703e+00 > > > 1 KSP Residual norm 5.460360737995e-14 > > > Line search: gnorm after quadratic fit 1.839556530796e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 31 SNES Function norm 1.839556530796e+02 > > > 0 KSP Residual norm 1.610676619931e+01 > > > 1 KSP Residual norm 6.703552136307e-13 > > > Line search: gnorm after quadratic fit 7.186735314913e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.905672430097e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.856766286600e+02 lambda=1.0830798014298563e-02 > > > Line search: Cubically determined step, current gnorm 1.836818937131e+02 lambda=3.3207362501459785e-03 > > > 32 SNES Function norm 1.836818937131e+02 > > > 0 KSP Residual norm 7.471722173131e+01 > > > 1 KSP Residual norm 2.671534648829e-12 > > > Line search: gnorm after quadratic fit 9.613379909411e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.509491298762e+04 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.808861367705e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.767283758299e+02 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.665421328348e+02 lambda=6.0369453941238101e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.869726717041e+02 lambda=1.4394327006264963e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.836897704575e+02 lambda=1.4394327006264963e-04 > > > Line search: Cubically determined step, current gnorm 1.836767951408e+02 lambda=5.5567420418543164e-05 > > > 33 SNES Function norm 1.836767951408e+02 > > > 0 KSP Residual norm 2.702367712138e+01 > > > 1 KSP Residual norm 2.731656687850e-12 > > > Line search: gnorm after quadratic fit 3.331563146098e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.723694790688e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.941243220944e+02 lambda=2.1443568774664485e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.847231733910e+02 lambda=2.7571330376860012e-03 > > > Line search: Cubically determined step, current gnorm 1.836356729409e+02 lambda=4.7841280418270480e-04 > > > 34 SNES Function norm 1.836356729409e+02 > > > 0 KSP Residual norm 1.228333177997e+01 > > > 1 KSP Residual norm 2.681127387880e-13 > > > Line search: gnorm after quadratic fit 6.936329223475e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.749327218775e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.871557327742e+02 lambda=1.4160505301999991e-02 > > > Line search: Cubically determined step, current gnorm 1.833523080682e+02 lambda=3.5196326548579192e-03 > > > 35 SNES Function norm 1.833523080682e+02 > > > 0 KSP Residual norm 3.531886257396e+02 > > > 1 KSP Residual norm 2.364634092895e-11 > > > Line search: gnorm after quadratic fit 3.994783047929e+06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.753715960726e+05 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.516669898185e+04 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.918985942348e+03 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.363599250418e+03 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.344906818752e+02 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.991088183980e+02 lambda=1.0108094710462592e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.834621681844e+02 lambda=1.0108094710462593e-04 > > > Line search: Cubically determined step, current gnorm 1.833517377324e+02 lambda=1.0108094710462594e-05 > > > 36 SNES Function norm 1.833517377324e+02 > > > 0 KSP Residual norm 9.005833507118e+01 > > > 1 KSP Residual norm 6.116387880629e-12 > > > Line search: gnorm after quadratic fit 8.899847103226e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.388111536526e+04 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.532652074749e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.864912734009e+02 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.421068789960e+02 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.873498120960e+02 lambda=2.1924025345283278e-03 > > > Line search: Cubically determined step, current gnorm 1.833506987706e+02 lambda=2.1924025345283280e-04 > > > 37 SNES Function norm 1.833506987706e+02 > > > 0 KSP Residual norm 1.548426525207e+01 > > > 1 KSP Residual norm 1.038038773942e-12 > > > Line search: gnorm after quadratic fit 6.702848665441e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.789880616078e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.846521504351e+02 lambda=1.0567302644323170e-02 > > > Line search: Cubically determined step, current gnorm 1.830548481815e+02 lambda=3.5274490352771972e-03 > > > 38 SNES Function norm 1.830548481815e+02 > > > 0 KSP Residual norm 1.523095478807e+01 > > > 1 KSP Residual norm 1.963823596119e-12 > > > Line search: gnorm after quadratic fit 9.255727478491e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.496757253461e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.863126241242e+02 lambda=9.3143291632966311e-03 > > > Line search: Cubically determined step, current gnorm 1.829091761403e+02 lambda=1.8107234819462800e-03 > > > 39 SNES Function norm 1.829091761403e+02 > > > 0 KSP Residual norm 1.311320726934e+01 > > > 1 KSP Residual norm 9.084170520902e-13 > > > Line search: gnorm after quadratic fit 7.488610069188e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.691148243365e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.885558228772e+02 lambda=1.9439894235886539e-02 > > > Line search: Cubically determined step, current gnorm 1.825540619134e+02 lambda=5.4967824488704169e-03 > > > 40 SNES Function norm 1.825540619134e+02 > > > 0 KSP Residual norm 1.218635557505e+01 > > > 1 KSP Residual norm 7.760485728617e-13 > > > Line search: gnorm after quadratic fit 6.636453826807e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.880828006022e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.830493790584e+02 lambda=6.6234802648049863e-03 > > > Line search: Cubically determined step, current gnorm 1.823397545268e+02 lambda=2.4308217464828865e-03 > > > 41 SNES Function norm 1.823397545268e+02 > > > 0 KSP Residual norm 9.456543593865e+00 > > > 1 KSP Residual norm 7.046593270309e-13 > > > Line search: gnorm after quadratic fit 3.369769163110e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.105230957789e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.817897533119e+02 lambda=9.1612481372917148e-03 > > > 42 SNES Function norm 1.817897533119e+02 > > > 0 KSP Residual norm 7.290035145805e+00 > > > 1 KSP Residual norm 3.198962158141e-12 > > > Line search: gnorm after quadratic fit 2.858311567415e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.965004842981e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.808845577764e+02 lambda=1.3826421990147811e-02 > > > 43 SNES Function norm 1.808845577764e+02 > > > 0 KSP Residual norm 7.256785036157e+00 > > > 1 KSP Residual norm 9.243179217625e-14 > > > Line search: gnorm after quadratic fit 2.534388176390e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.916726818893e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.797953125543e+02 lambda=1.3677747819164022e-02 > > > 44 SNES Function norm 1.797953125543e+02 > > > 0 KSP Residual norm 1.716201096352e+01 > > > 1 KSP Residual norm 2.701418800808e-13 > > > Line search: gnorm after quadratic fit 1.331064301474e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.461842246267e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.920668830294e+02 lambda=1.2856504859057132e-02 > > > Line search: Cubically determined step, current gnorm 1.797121460957e+02 lambda=1.4396611381500967e-03 > > > 45 SNES Function norm 1.797121460957e+02 > > > 0 KSP Residual norm 6.613432967985e+00 > > > 1 KSP Residual norm 1.357752977076e-13 > > > Line search: gnorm after quadratic fit 2.721288927858e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.939638282615e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.787985482018e+02 lambda=1.2647907914070569e-02 > > > 46 SNES Function norm 1.787985482018e+02 > > > 0 KSP Residual norm 1.225736349281e+01 > > > 1 KSP Residual norm 3.819378790812e-13 > > > Line search: gnorm after quadratic fit 4.548006065036e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.304803559060e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.787344729174e+02 lambda=8.9002284237256531e-03 > > > 47 SNES Function norm 1.787344729174e+02 > > > 0 KSP Residual norm 6.302465402340e+00 > > > 1 KSP Residual norm 6.980931947122e-14 > > > Line search: gnorm after quadratic fit 2.879477700004e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.980806946742e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.780128006935e+02 lambda=1.0223293444602008e-02 > > > 48 SNES Function norm 1.780128006935e+02 > > > 0 KSP Residual norm 4.323829277968e+00 > > > 1 KSP Residual norm 5.223881369308e-13 > > > Line search: gnorm after quadratic fit 1.957928151218e+02 > > > Line search: Cubically determined step, current gnorm 1.768899805640e+02 lambda=5.0000000000000003e-02 > > > 49 SNES Function norm 1.768899805640e+02 > > > 0 KSP Residual norm 2.249256107033e+00 > > > 1 KSP Residual norm 3.624400957270e-14 > > > Line search: gnorm after quadratic fit 1.704782114773e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 50 SNES Function norm 1.704782114773e+02 > > > 0 SNES Function norm 3.513783397332e+03 > > > 0 KSP Residual norm 1.650214950648e+01 > > > 1 KSP Residual norm 3.574269752690e-13 > > > Line search: gnorm after quadratic fit 3.155830404050e+03 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 1 SNES Function norm 3.155830404050e+03 > > > 0 KSP Residual norm 1.443734018042e+01 > > > 1 KSP Residual norm 3.685565191058e-13 > > > Line search: Using full step: fnorm 3.155830404050e+03 gnorm 8.581212204155e+02 > > > 2 SNES Function norm 8.581212204155e+02 > > > 0 KSP Residual norm 2.492601775565e+00 > > > 1 KSP Residual norm 9.698440210389e-14 > > > Line search: Using full step: fnorm 8.581212204155e+02 gnorm 7.018609898542e+02 > > > 3 SNES Function norm 7.018609898542e+02 > > > 0 KSP Residual norm 1.740320986421e+00 > > > 1 KSP Residual norm 2.868780682435e-14 > > > Line search: Using full step: fnorm 7.018609898542e+02 gnorm 2.135824235887e+02 > > > 4 SNES Function norm 2.135824235887e+02 > > > 0 KSP Residual norm 1.647413497077e+00 > > > 1 KSP Residual norm 2.731226225666e-14 > > > Line search: gnorm after quadratic fit 1.936469032649e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 5 SNES Function norm 1.936469032649e+02 > > > 0 KSP Residual norm 1.406615972124e+00 > > > 1 KSP Residual norm 3.167179626699e-14 > > > Line search: gnorm after quadratic fit 1.755362571467e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 6 SNES Function norm 1.755362571467e+02 > > > 0 KSP Residual norm 1.480681706594e+00 > > > 1 KSP Residual norm 2.935210968935e-14 > > > Line search: gnorm after quadratic fit 1.597659506616e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 7 SNES Function norm 1.597659506616e+02 > > > 0 KSP Residual norm 4.013154698097e+00 > > > 1 KSP Residual norm 1.021628704832e-13 > > > Line search: gnorm after quadratic fit 1.728408060966e+02 > > > Line search: Cubically determined step, current gnorm 1.570815760721e+02 lambda=5.0000000000000003e-02 > > > 8 SNES Function norm 1.570815760721e+02 > > > 0 KSP Residual norm 1.510335662636e+00 > > > 1 KSP Residual norm 2.728243244724e-14 > > > Line search: gnorm after quadratic fit 1.450162880692e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 9 SNES Function norm 1.450162880692e+02 > > > 0 KSP Residual norm 1.923349271077e+01 > > > 1 KSP Residual norm 1.640711956406e-11 > > > Line search: gnorm after quadratic fit 1.016537223115e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.584263092048e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.490729346583e+02 lambda=9.3725990358703350e-03 > > > Line search: Cubically determined step, current gnorm 1.449349273006e+02 lambda=1.5464889706033082e-03 > > > 10 SNES Function norm 1.449349273006e+02 > > > 0 KSP Residual norm 1.154999084194e+01 > > > 1 KSP Residual norm 1.292167633338e-11 > > > Line search: gnorm after quadratic fit 6.060386918705e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.236630526035e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.491201927819e+02 lambda=1.6816056300124185e-02 > > > Line search: Cubically determined step, current gnorm 1.447023047013e+02 lambda=4.1484374564153808e-03 > > > 11 SNES Function norm 1.447023047013e+02 > > > 0 KSP Residual norm 7.278906180502e+00 > > > 1 KSP Residual norm 2.815632651924e-12 > > > Line search: gnorm after quadratic fit 2.512278711773e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.624350957814e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.441656049510e+02 lambda=1.0879389002513012e-02 > > > 12 SNES Function norm 1.441656049510e+02 > > > 0 KSP Residual norm 4.449836480267e+00 > > > 1 KSP Residual norm 3.152365624813e-13 > > > Line search: gnorm after quadratic fit 1.749680739878e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.458763435996e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.425715025152e+02 lambda=2.2766809271842225e-02 > > > 13 SNES Function norm 1.425715025152e+02 > > > 0 KSP Residual norm 4.218495037726e+00 > > > 1 KSP Residual norm 1.398472536142e-12 > > > Line search: gnorm after quadratic fit 1.645159536467e+02 > > > Line search: Cubically determined step, current gnorm 1.421991559212e+02 lambda=4.1883769431247941e-02 > > > 14 SNES Function norm 1.421991559212e+02 > > > 0 KSP Residual norm 1.968853538608e+00 > > > 1 KSP Residual norm 7.594023450519e-12 > > > Line search: gnorm after quadratic fit 1.350960142124e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 15 SNES Function norm 1.350960142124e+02 > > > 0 KSP Residual norm 3.444721686085e+00 > > > 1 KSP Residual norm 5.312609674019e-14 > > > Line search: gnorm after quadratic fit 1.472880565107e+02 > > > Line search: Cubically determined step, current gnorm 1.336714620145e+02 lambda=4.1341550820829437e-02 > > > 16 SNES Function norm 1.336714620145e+02 > > > 0 KSP Residual norm 3.276288899397e+00 > > > 1 KSP Residual norm 8.394674946715e-14 > > > Line search: gnorm after quadratic fit 1.459274497150e+02 > > > Line search: Cubically determined step, current gnorm 1.327618539486e+02 lambda=5.0000000000000003e-02 > > > 17 SNES Function norm 1.327618539486e+02 > > > 0 KSP Residual norm 2.630052244303e+00 > > > 1 KSP Residual norm 4.351283410507e-14 > > > Line search: gnorm after quadratic fit 1.350378060116e+02 > > > Line search: Cubically determined step, current gnorm 1.299403903934e+02 lambda=4.9913529436269283e-02 > > > 18 SNES Function norm 1.299403903934e+02 > > > 0 KSP Residual norm 6.124953430138e+00 > > > 1 KSP Residual norm 2.295381352938e-13 > > > Line search: gnorm after quadratic fit 2.275621676963e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.469611730657e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.294890694898e+02 lambda=1.0071939100661648e-02 > > > 19 SNES Function norm 1.294890694898e+02 > > > 0 KSP Residual norm 1.036733907011e+01 > > > 1 KSP Residual norm 1.800941381283e-13 > > > Line search: gnorm after quadratic fit 3.844879463595e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.875071148504e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 1.294494430642e+02 lambda=5.0000000000000010e-03 > > > 20 SNES Function norm 1.294494430642e+02 > > > 0 KSP Residual norm 8.224001595443e+00 > > > 1 KSP Residual norm 3.337810156182e-13 > > > Line search: gnorm after quadratic fit 3.332325263497e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.682441841234e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.294720538860e+02 lambda=8.5401597581228530e-03 > > > Line search: Cubically determined step, current gnorm 1.291762382985e+02 lambda=4.2555418164960989e-03 > > > 21 SNES Function norm 1.291762382985e+02 > > > 0 KSP Residual norm 3.920749219860e+01 > > > 1 KSP Residual norm 1.610902886435e-12 > > > Line search: gnorm after quadratic fit 3.472422440640e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.023065712859e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.228184088700e+02 lambda=1.6004598823093592e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.298607525058e+02 lambda=1.6004598823093593e-03 > > > Line search: Cubically determined step, current gnorm 1.291643460998e+02 lambda=1.9319076533745672e-04 > > > 22 SNES Function norm 1.291643460998e+02 > > > 0 KSP Residual norm 1.520092314848e+02 > > > 1 KSP Residual norm 7.089159192434e-11 > > > Line search: gnorm after quadratic fit 2.752539686422e+05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.237188995536e+04 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.484370498858e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.571039994484e+03 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.280898858362e+02 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.708927009106e+02 lambda=2.6114913411793973e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.294919567784e+02 lambda=2.6114913411793975e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291645609810e+02 lambda=2.6114913411793977e-05 > > > Line search: Cubically determined step, current gnorm 1.291635530596e+02 lambda=1.2278773895355162e-05 > > > 23 SNES Function norm 1.291635530596e+02 > > > 0 KSP Residual norm 7.569206058965e+02 > > > 1 KSP Residual norm 3.454693729751e-11 > > > Line search: gnorm after quadratic fit 2.570888738395e+07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.064965025187e+06 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.498514098182e+05 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.807487005202e+04 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.233167830543e+03 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.396736912757e+03 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.547572543330e+02 lambda=1.2623406091699435e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.335889024473e+02 lambda=1.8542137907683829e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.292059042479e+02 lambda=1.8542137907683831e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291637618568e+02 lambda=1.8542137907683832e-06 > > > Line search: Cubically determined step, current gnorm 1.291635210734e+02 lambda=4.9524172913414387e-07 > > > 24 SNES Function norm 1.291635210734e+02 > > > 0 KSP Residual norm 3.761913422861e+03 > > > 1 KSP Residual norm 6.181718776929e-10 > > > Line search: gnorm after quadratic fit 3.342370445037e+09 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.218326646111e+08 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.375128803204e+07 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.980626157021e+06 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.407418671219e+05 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.357321025399e+05 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.188948059047e+04 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.105117929713e+03 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.331054736818e+02 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.942479792843e+02 lambda=1.9412500272460620e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.436944624694e+02 lambda=6.4483223307578726e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.292972287211e+02 lambda=6.4483223307578726e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291647778160e+02 lambda=6.4483223307578730e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635261433e+02 lambda=6.4483223307578730e-08 > > > Line search: Cubically determined step, current gnorm 1.291635197798e+02 lambda=2.0042115918485846e-08 > > > 25 SNES Function norm 1.291635197798e+02 > > > 0 KSP Residual norm 1.874745766083e+04 > > > 1 KSP Residual norm 1.476978150334e-09 > > > Line search: gnorm after quadratic fit 4.089262111368e+11 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.101717203770e+10 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.352565940292e+09 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.879613196620e+08 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.698613558125e+07 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.175566265039e+07 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.382919964952e+06 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.545431975334e+05 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.713561369103e+04 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.031789308419e+03 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.205847020738e+02 lambda=9.7656250000000005e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.957203153158e+02 lambda=2.8132879163728503e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.297923302791e+02 lambda=2.8132879163728504e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291698100579e+02 lambda=2.8132879163728504e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635794525e+02 lambda=2.8132879163728506e-08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635200489e+02 lambda=2.8132879163728508e-09 > > > Line search: Cubically determined step, current gnorm 1.291635197275e+02 lambda=8.0832061492461345e-10 > > > 26 SNES Function norm 1.291635197275e+02 > > > 0 KSP Residual norm 9.248381077528e+04 > > > 1 KSP Residual norm 7.262307068447e-09 > > > Line search: gnorm after quadratic fit 4.920647210624e+13 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.153216818065e+12 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.697543960375e+11 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.637004379805e+10 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.208402653149e+10 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.519988135798e+09 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.923903214787e+08 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.465663001976e+07 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.238603967195e+06 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.459179143177e+05 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.676301042792e+04 lambda=9.7656250000000005e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.135808875752e+04 lambda=4.8828125000000003e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.275714918657e+03 lambda=2.4414062500000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.719037747616e+02 lambda=1.2207031250000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.039826156716e+02 lambda=5.5609199181402721e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.308092967809e+02 lambda=9.1057337296683134e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291796742824e+02 lambda=9.1057337296683134e-08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291636800174e+02 lambda=9.1057337296683134e-09 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635212255e+02 lambda=9.1057337296683134e-10 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635197320e+02 lambda=9.1057337296683139e-11 > > > Line search: Cubically determined step, current gnorm 1.291635197254e+02 lambda=3.2898162617097329e-11 > > > 27 SNES Function norm 1.291635197254e+02 > > > 0 KSP Residual norm 4.818745996826e+05 > > > 1 KSP Residual norm 3.300979345194e-08 > > > Line search: gnorm after quadratic fit 6.957046028867e+15 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.695654311477e+14 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.086793500688e+14 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.358083744813e+13 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.696584801696e+12 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.118183549773e+11 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.641372080976e+10 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.285878535769e+09 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.068045470276e+08 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.988290932539e+07 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.001404304764e+06 lambda=9.7656250000000005e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.962234585736e+05 lambda=4.8828125000000003e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.648190078115e+04 lambda=2.4414062500000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.098288624714e+03 lambda=1.2207031250000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.025132922751e+03 lambda=6.1035156250000003e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.536770142392e+02 lambda=3.0517578125000002e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.529553964021e+02 lambda=6.6615844706846272e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.293970371303e+02 lambda=6.6615844706846277e-08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291658631829e+02 lambda=6.6615844706846284e-09 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635430890e+02 lambda=6.6615844706846284e-10 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635199508e+02 lambda=6.6615844706846284e-11 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635197268e+02 lambda=6.6615844706846284e-12 > > > Line search: Cubically determined step, current gnorm 1.291635197253e+02 lambda=1.2496728806533799e-12 > > > 28 SNES Function norm 1.291635197253e+02 > > > 0 KSP Residual norm 2.124622394867e+06 > > > 1 KSP Residual norm 2.766225333896e-07 > > > Line search: gnorm after quadratic fit 5.963587884154e+17 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.454611858824e+16 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.318582340500e+15 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.164902175749e+15 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.456326197371e+14 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.820904039469e+13 lambda=3.1250000000000002e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.277371273495e+12 lambda=1.5625000000000001e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.849819609184e+11 lambda=7.8125000000000004e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.570050545145e+10 lambda=3.9062500000000002e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.482064028328e+09 lambda=1.9531250000000001e-04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.651631635063e+08 lambda=9.7656250000000005e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.188623828904e+07 lambda=4.8828125000000003e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.302868645305e+06 lambda=2.4414062500000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.245214424313e+06 lambda=1.2207031250000001e-05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.775004618570e+05 lambda=6.1035156250000003e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.810228834086e+04 lambda=3.0517578125000002e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.148910945566e+03 lambda=1.5258789062500001e-06 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.133679879416e+03 lambda=7.6293945312500004e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.382468615011e+02 lambda=3.8146972656250002e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.519773483633e+02 lambda=1.4103864371136453e-07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.293690599792e+02 lambda=1.4103864371136454e-08 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291655645282e+02 lambda=1.4103864371136455e-09 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635401518e+02 lambda=1.4103864371136456e-10 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635199283e+02 lambda=1.4103864371136456e-11 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635197272e+02 lambda=1.4103864371136456e-12 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635197253e+02 lambda=1.4103864371136457e-13 > > > Line search: unable to find good step length! After 25 tries > > > Line search: fnorm=1.2916351972528861e+02, gnorm=1.2916351972529532e+02, ynorm=2.1246218291095798e+06, minlambda=9.9999999999999998e-13, lambda=1.4103864371136457e-13, initial slope=-1.6683210999382733e+04 > > > 0 SNES Function norm 7.158176401507e+03 > > > 0 KSP Residual norm 7.545626598553e+02 > > > 1 KSP Residual norm 2.192822940623e-11 > > > Line search: gnorm after quadratic fit 6.003975664723e+07 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.501930637484e+06 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.380142516806e+05 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.179837352860e+05 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.656902039419e+04 lambda=6.2500000000000003e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.340091686120e+03 lambda=3.1250000000000002e-03 > > > Line search: Cubically determined step, current gnorm 7.127478647243e+03 lambda=1.5625000000000001e-03 > > > 1 SNES Function norm 7.127478647243e+03 > > > 0 KSP Residual norm 3.139792512249e+01 > > > 1 KSP Residual norm 5.765552480238e-13 > > > Line search: gnorm after quadratic fit 7.131728282938e+03 > > > Line search: Cubically determined step, current gnorm 6.730387269330e+03 lambda=5.0000000000000003e-02 > > > 2 SNES Function norm 6.730387269330e+03 > > > 0 KSP Residual norm 2.247436817553e+01 > > > 1 KSP Residual norm 4.129717651221e-13 > > > Line search: gnorm after quadratic fit 6.018304311910e+03 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 3 SNES Function norm 6.018304311910e+03 > > > 0 KSP Residual norm 1.605973421081e+01 > > > 1 KSP Residual norm 3.614891198134e-13 > > > Line search: gnorm after quadratic fit 5.394599276028e+03 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 4 SNES Function norm 5.394599276028e+03 > > > 0 KSP Residual norm 1.491002227850e+01 > > > 1 KSP Residual norm 5.905756964447e-13 > > > Line search: gnorm after quadratic fit 4.845108544722e+03 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 5 SNES Function norm 4.845108544722e+03 > > > 0 KSP Residual norm 1.562997766581e+02 > > > 1 KSP Residual norm 5.722461855805e-12 > > > Line search: gnorm after quadratic fit 1.663505509947e+05 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.368547472010e+04 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.067825049920e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.852173464442e+03 lambda=1.2500000000000001e-02 > > > Line search: Cubically determined step, current gnorm 4.819549937425e+03 lambda=6.2500000000000003e-03 > > > 6 SNES Function norm 4.819549937425e+03 > > > 0 KSP Residual norm 1.652787385042e+01 > > > 1 KSP Residual norm 7.774483442550e-13 > > > Line search: gnorm after quadratic fit 2.868840270198e+03 > > > Line search: Quadratically determined step, lambda=3.9586658383856743e-01 > > > 7 SNES Function norm 2.868840270198e+03 > > > 0 KSP Residual norm 1.220061851091e+01 > > > 1 KSP Residual norm 4.785407437718e-13 > > > Line search: gnorm after quadratic fit 2.616720732407e+03 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 8 SNES Function norm 2.616720732407e+03 > > > 0 KSP Residual norm 2.884722153958e+01 > > > 1 KSP Residual norm 5.474553921306e-13 > > > Line search: gnorm after quadratic fit 3.025386805317e+03 > > > Line search: Cubically determined step, current gnorm 2.572110173067e+03 lambda=5.0000000000000003e-02 > > > 9 SNES Function norm 2.572110173067e+03 > > > 0 KSP Residual norm 5.239447686736e+01 > > > 1 KSP Residual norm 1.006906008399e-12 > > > Line search: gnorm after quadratic fit 5.237562098046e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.722529781980e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 2.553072891461e+03 lambda=2.5000000000000001e-02 > > > 10 SNES Function norm 2.553072891461e+03 > > > 0 KSP Residual norm 6.511316788880e+00 > > > 1 KSP Residual norm 1.340296659008e-13 > > > Line search: gnorm after quadratic fit 2.299704119080e+03 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 11 SNES Function norm 2.299704119080e+03 > > > 0 KSP Residual norm 5.268131426587e+00 > > > 1 KSP Residual norm 1.017563310127e-13 > > > Line search: Using full step: fnorm 2.299704119080e+03 gnorm 7.642690039388e+02 > > > 12 SNES Function norm 7.642690039388e+02 > > > 0 KSP Residual norm 1.467735721574e+01 > > > 1 KSP Residual norm 1.090242963543e-12 > > > Line search: gnorm after quadratic fit 1.042766084830e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.924803860137e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 7.581126971182e+02 lambda=1.8508848315139208e-02 > > > 13 SNES Function norm 7.581126971182e+02 > > > 0 KSP Residual norm 2.222609581896e+00 > > > 1 KSP Residual norm 5.661437314341e-14 > > > Line search: gnorm after quadratic fit 6.235337602260e+02 > > > Line search: Quadratically determined step, lambda=2.1172883827013136e-01 > > > 14 SNES Function norm 6.235337602260e+02 > > > 0 KSP Residual norm 3.080209609798e+00 > > > 1 KSP Residual norm 6.073476899313e-14 > > > Line search: gnorm after quadratic fit 5.704745248520e+02 > > > Line search: Quadratically determined step, lambda=1.0142301129466913e-01 > > > 15 SNES Function norm 5.704745248520e+02 > > > 0 KSP Residual norm 5.628316803979e+00 > > > 1 KSP Residual norm 9.930477041779e-14 > > > Line search: gnorm after quadratic fit 5.401354794776e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 16 SNES Function norm 5.401354794776e+02 > > > 0 KSP Residual norm 2.052541406719e+01 > > > 1 KSP Residual norm 4.328836834239e-13 > > > Line search: gnorm after quadratic fit 1.709850100987e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.717966555703e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.414032576976e+02 lambda=8.7805694170804971e-03 > > > Line search: Cubically determined step, current gnorm 5.391967144330e+02 lambda=3.6341472475199424e-03 > > > 17 SNES Function norm 5.391967144330e+02 > > > 0 KSP Residual norm 2.246993769488e+00 > > > 1 KSP Residual norm 5.078373642913e-14 > > > Line search: gnorm after quadratic fit 4.939618639951e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 18 SNES Function norm 4.939618639951e+02 > > > 0 KSP Residual norm 2.155867648564e+00 > > > 1 KSP Residual norm 4.438622106380e-14 > > > Line search: gnorm after quadratic fit 4.334377322188e+02 > > > Line search: Quadratically determined step, lambda=1.5092486954829210e-01 > > > 19 SNES Function norm 4.334377322188e+02 > > > 0 KSP Residual norm 8.318284791610e+00 > > > 1 KSP Residual norm 6.910116607023e-13 > > > Line search: gnorm after quadratic fit 6.148799641401e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.502386288041e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 4.297879862602e+02 lambda=1.9565738732695813e-02 > > > 20 SNES Function norm 4.297879862602e+02 > > > 0 KSP Residual norm 7.593855254976e+01 > > > 1 KSP Residual norm 1.300639045149e-12 > > > Line search: gnorm after quadratic fit 7.318016560287e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.832525429452e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.543595712952e+03 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.752901058720e+02 lambda=1.2500000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.309726315570e+02 lambda=1.2500000000000002e-03 > > > Line search: Cubically determined step, current gnorm 4.297464967378e+02 lambda=2.0986409143217158e-04 > > > 21 SNES Function norm 4.297464967378e+02 > > > 0 KSP Residual norm 8.492609701850e+00 > > > 1 KSP Residual norm 2.830329105288e-13 > > > Line search: gnorm after quadratic fit 6.575200413213e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.532760802544e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 4.268212296998e+02 lambda=1.8460064973695799e-02 > > > 22 SNES Function norm 4.268212296998e+02 > > > 0 KSP Residual norm 2.527155905469e+00 > > > 1 KSP Residual norm 2.235724978394e-13 > > > Line search: gnorm after quadratic fit 3.958132075117e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 23 SNES Function norm 3.958132075117e+02 > > > 0 KSP Residual norm 3.425644398425e+00 > > > 1 KSP Residual norm 7.166017790799e-14 > > > Line search: gnorm after quadratic fit 3.803199338641e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 24 SNES Function norm 3.803199338641e+02 > > > 0 KSP Residual norm 3.581435186688e+00 > > > 1 KSP Residual norm 1.730091027109e-13 > > > Line search: gnorm after quadratic fit 3.678433353709e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 25 SNES Function norm 3.678433353709e+02 > > > 0 KSP Residual norm 2.817439291614e+00 > > > 1 KSP Residual norm 8.592333136485e-13 > > > Line search: gnorm after quadratic fit 3.472671313564e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 26 SNES Function norm 3.472671313564e+02 > > > 0 KSP Residual norm 1.830066839089e+00 > > > 1 KSP Residual norm 3.248934231575e-14 > > > Line search: gnorm after quadratic fit 3.195079998571e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 27 SNES Function norm 3.195079998571e+02 > > > 0 KSP Residual norm 3.775823654589e+00 > > > 1 KSP Residual norm 1.316233059492e-13 > > > Line search: gnorm after quadratic fit 3.252874639934e+02 > > > Line search: Cubically determined step, current gnorm 3.125168318399e+02 lambda=5.0000000000000003e-02 > > > 28 SNES Function norm 3.125168318399e+02 > > > 0 KSP Residual norm 3.892613775622e+00 > > > 1 KSP Residual norm 7.093200713216e-11 > > > Line search: gnorm after quadratic fit 3.137590389484e+02 > > > Line search: Cubically determined step, current gnorm 3.045559021319e+02 lambda=5.0000000000000003e-02 > > > 29 SNES Function norm 3.045559021319e+02 > > > 0 KSP Residual norm 2.364531179390e+00 > > > 1 KSP Residual norm 1.615423543115e-12 > > > Line search: gnorm after quadratic fit 2.864449141431e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 30 SNES Function norm 2.864449141431e+02 > > > 0 KSP Residual norm 5.187063704081e+00 > > > 1 KSP Residual norm 4.254799504045e-13 > > > Line search: gnorm after quadratic fit 3.171238299438e+02 > > > Line search: Cubically determined step, current gnorm 2.859321807369e+02 lambda=4.9550691080557742e-02 > > > 31 SNES Function norm 2.859321807369e+02 > > > 0 KSP Residual norm 2.400449127985e+01 > > > 1 KSP Residual norm 5.221032480453e-13 > > > Line search: gnorm after quadratic fit 1.812538817802e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.647888939229e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.905120335847e+02 lambda=7.3371687404129469e-03 > > > Line search: Cubically determined step, current gnorm 2.857698450683e+02 lambda=1.3231746793531958e-03 > > > 32 SNES Function norm 2.857698450683e+02 > > > 0 KSP Residual norm 7.438521293559e+00 > > > 1 KSP Residual norm 1.293652874831e-12 > > > Line search: gnorm after quadratic fit 3.600694148787e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.932936811991e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 2.832774969882e+02 lambda=1.8636088141277370e-02 > > > 33 SNES Function norm 2.832774969882e+02 > > > 0 KSP Residual norm 2.676138557891e+00 > > > 1 KSP Residual norm 5.204105674042e-12 > > > Line search: gnorm after quadratic fit 2.698470565576e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 34 SNES Function norm 2.698470565576e+02 > > > 0 KSP Residual norm 1.009562156863e+01 > > > 1 KSP Residual norm 3.544140587695e-13 > > > Line search: gnorm after quadratic fit 5.672695948559e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.197216154647e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 2.694068135292e+02 lambda=1.0762403784106927e-02 > > > 35 SNES Function norm 2.694068135292e+02 > > > 0 KSP Residual norm 3.927549314525e+00 > > > 1 KSP Residual norm 2.619134786598e-13 > > > Line search: gnorm after quadratic fit 2.646675787349e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 36 SNES Function norm 2.646675787349e+02 > > > 0 KSP Residual norm 3.630219417922e+01 > > > 1 KSP Residual norm 1.546302717349e-12 > > > Line search: gnorm after quadratic fit 1.827432666108e+04 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.342968941151e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.008633273369e+02 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.490753494196e+02 lambda=1.2345129233072847e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.682474011960e+02 lambda=3.3291959087019770e-03 > > > Line search: Cubically determined step, current gnorm 2.646227701989e+02 lambda=4.0529212866107715e-04 > > > 37 SNES Function norm 2.646227701989e+02 > > > 0 KSP Residual norm 8.122774697994e+00 > > > 1 KSP Residual norm 1.316362046092e-13 > > > Line search: gnorm after quadratic fit 4.731092571363e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.030088374328e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 2.637462652877e+02 lambda=9.1057248517509397e-03 > > > 38 SNES Function norm 2.637462652877e+02 > > > 0 KSP Residual norm 2.601520363063e+00 > > > 1 KSP Residual norm 1.060764270007e-12 > > > Line search: gnorm after quadratic fit 2.536856446094e+02 > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > 39 SNES Function norm 2.536856446094e+02 > > > 0 KSP Residual norm 5.447955134327e+01 > > > 1 KSP Residual norm 2.556989975730e-12 > > > Line search: gnorm after quadratic fit 9.199250935618e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.998238940105e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.227083769291e+02 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.852215674478e+02 lambda=8.5024965111563117e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.537821339347e+02 lambda=8.5024965111563122e-04 > > > Line search: Cubically determined step, current gnorm 2.536484146652e+02 lambda=2.9594242443314720e-04 > > > 40 SNES Function norm 2.536484146652e+02 > > > 0 KSP Residual norm 3.357359266965e+01 > > > 1 KSP Residual norm 8.485166742752e-11 > > > Line search: gnorm after quadratic fit 3.327150899857e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.660943990394e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.428891921377e+02 lambda=2.2262238648584176e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.550059920785e+02 lambda=3.9120439672600755e-03 > > > Line search: Cubically determined step, current gnorm 2.535425543202e+02 lambda=8.8078244093807846e-04 > > > 41 SNES Function norm 2.535425543202e+02 > > > 0 KSP Residual norm 1.982789391732e+01 > > > 1 KSP Residual norm 1.156473750758e-11 > > > Line search: gnorm after quadratic fit 9.648483369708e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.023504841042e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.554919970151e+02 lambda=8.7092873850291869e-03 > > > Line search: Cubically determined step, current gnorm 2.532490636747e+02 lambda=2.4564558988847251e-03 > > > 42 SNES Function norm 2.532490636747e+02 > > > 0 KSP Residual norm 1.762994613361e+01 > > > 1 KSP Residual norm 4.550684860593e-12 > > > Line search: gnorm after quadratic fit 6.772107527838e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.370541870778e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.532869639177e+02 lambda=7.7662700854918328e-03 > > > Line search: Cubically determined step, current gnorm 2.527651129995e+02 lambda=3.8686733161537824e-03 > > > 43 SNES Function norm 2.527651129995e+02 > > > 0 KSP Residual norm 1.559278923951e+01 > > > 1 KSP Residual norm 1.060470887103e-11 > > > Line search: gnorm after quadratic fit 7.344361373020e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.498001534426e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.530518382567e+02 lambda=7.6730113050967469e-03 > > > Line search: Cubically determined step, current gnorm 2.523423548732e+02 lambda=3.4156098513217236e-03 > > > 44 SNES Function norm 2.523423548732e+02 > > > 0 KSP Residual norm 1.190500639095e+01 > > > 1 KSP Residual norm 6.311739265577e-12 > > > Line search: gnorm after quadratic fit 4.875196633557e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.933215922947e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 2.516782376717e+02 lambda=9.8878729665301743e-03 > > > 45 SNES Function norm 2.516782376717e+02 > > > 0 KSP Residual norm 1.003632001309e+01 > > > 1 KSP Residual norm 7.039473047666e-13 > > > Line search: gnorm after quadratic fit 3.417133560813e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.636443273929e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 2.499729768042e+02 lambda=1.5332495922160540e-02 > > > 46 SNES Function norm 2.499729768042e+02 > > > 0 KSP Residual norm 5.252587112411e+01 > > > 1 KSP Residual norm 2.072629114336e-12 > > > Line search: gnorm after quadratic fit 7.891803681498e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.819076698717e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.911876424956e+02 lambda=2.4538865368827514e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.688195882303e+02 lambda=6.5764457912135515e-03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.500076295129e+02 lambda=6.5764457912135523e-04 > > > Line search: Cubically determined step, current gnorm 2.499390700783e+02 lambda=2.7231956365922875e-04 > > > 47 SNES Function norm 2.499390700783e+02 > > > 0 KSP Residual norm 4.007648116930e+01 > > > 1 KSP Residual norm 5.646654234336e-11 > > > Line search: gnorm after quadratic fit 6.276152857499e+03 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.418274035925e+03 lambda=5.0000000000000003e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.785345842563e+02 lambda=2.5000000000000001e-02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.665412152699e+02 lambda=8.0607289886479045e-03 > > > Line search: Cubically determined step, current gnorm 2.499109739904e+02 lambda=8.0607289886479045e-04 > > > 48 SNES Function norm 2.499109739904e+02 > > > 0 KSP Residual norm 1.339756751889e+01 > > > 1 KSP Residual norm 2.559175980945e-13 > > > Line search: gnorm after quadratic fit 6.052259901869e+02 > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.217431518450e+02 lambda=5.0000000000000003e-02 > > > Line search: Cubically determined step, current gnorm 2.496541765916e+02 lambda=7.0239599632283649e-03 > > > 49 SNES Function norm 2.496541765916e+02 > > > 0 KSP Residual norm 5.340771873687e+00 > > > 1 KSP Residual norm 1.207454778077e-13 > > > Line search: gnorm after quadratic fit 2.760767095070e+02 > > > Line search: Cubically determined step, current gnorm 2.491630276458e+02 lambda=5.0000000000000003e-02 > > > 50 SNES Function norm 2.491630276458e+02 > > > > > > > > > On Sat, Aug 26, 2017 at 11:45 PM, Barry Smith wrote: > > > > > > > On Aug 26, 2017, at 10:43 PM, zakaryah . wrote: > > > > > > > > Hi Barry - many thanks for taking the time to understand my many problems and providing so much help. > > > > > > > > The reason I was concerned that I could not alter the linesearch was when I tried to use bt instead of the L-BFGS default, cp, the code crashed with an error like "Could not get Jacobian". Maybe this is an incompatibility like you say, since L-BFGS only uses the initial Jacobian and I never tried setting the scale type. > > > > > > > > I took your advice and tried to shrink the problem. First I tried shrinking by a factor 1000 but this converged very quickly with all test data I could provide, including the data which was problematic with the large grid. So I settled for a reduction in size by a factor 125. The grid size is 13,230. This is a decent test case because the solver fails to converge with the options I was using before, and it is small enough that I can run it with the options you suggested (-snes_fd_color -snes_type newtonls -snes_monitor -snes_linesearch_monitor -ksp_monitor -pc_type lu). > > > > > > > > The output is 1800 lines long - how shall I share it? > > > > > > Just email it, that is small enough for email. > > > > > > Barry > > > > > > > > > > > > > > > > > > > > > > > On Sat, Aug 26, 2017 at 7:38 PM, Barry Smith wrote: > > > > > > > > > On Aug 26, 2017, at 5:56 PM, zakaryah . wrote: > > > > > > > > > > I'm using PETSc's SNES methods to solve PDEs which result from Euler-Lagrange equations for the strain energy of a 3D displacement field. There is an additional term in the Lagrangian which describes external forces which arise from various data sets, and that term contains nonlinearities (field terms higher than linear). The grid has about 1.6e6 elements, and the displacement field has 3 components at each grid element. > > > > > > > > > > I'm trying to solve a sequence of successively more complicated equations, and the latest equation is failing to converge on some data sets. In particular, the methods were successful for the infinitesimal bulk strain (compression) energy, as well as the full infinitesimal strain energy (bulk + shear), but I'm now trying to generalize to the finite strain, as certain data sets are known to result from displacement fields for which the infinitesimal strain is a poor approximation. > > > > > > > > > > I'm using a DMDA, closely following example 48, and my preferred solver is L-BFGS. > > > > > > > > So you are using ? > > > > > > > > -snes_type qn -snes_qn_type lbfgs > > > > > > > > > > > > > > I have read the FAQs "Why is Newton's method not converging??" and "Why is my iterative linear solver not converging??"? which have raised a number of questions: > > > > > > > > Quasi Newton methods either don't use Jacobians or use only the initial Jacobian (the idea behind quasi-Newton methods is to approximate Jacobian information from previous iterations without having the user compute a Jacobian at each iteration). With PETSc's qn it only uses the Jacobian if you use the option > > > > > > > > -snes_qn_scale_type Jacobian > > > > > > > > otherwise the Jacobian is never computed or used > > > > > > > > > > > > > > > > > > Is there documentation for the DMDA/SNES methods somewhere? I don't understand these very well. For example, I am not allocating any matrix for the global Jacobian, and I believe this prevents me from changing the line search. If I'm mistaken I would love to see an example of changing the line search type while using DMDA/SNES. > > > > > > > > Whether you provide a Jacobian or not is orthogonal to the line search. > > > > > > > > You should be able to change the line search with > > > > > > > > -snes_linesearch_type bt or nleqerr or basic or l2 or cp > > > > > > > > not all of them may work with qn > > > > > > > > > > > > > > > > > > I don't know how to interpret the linesearch monitor. Even for problems which are converging properly, the linesearch monitor reports "lssucceed=0" on every iteration. Is this a problem? > > > > > > > > It returns a 0 if the line search does not believe it has achieved "sufficient decrease" in the function norm (or possibly some other measure of decrease) you should run -snes_linesearch_monitor also with the option -snes_monitor to see what is happening to the function norm > > > > > > > > For qn you can add the option > > > > > > > > -snes_qn_monitor > > > > > > > > to get more detailed monitoring > > > > > > > > > > > > > > > > > > I'm also having trouble understanding the methods for troubleshooting. I suspect that I've made an error in the analytical Jacobian, which has a rather large number of non-zero elements, but I have no idea how to use -snes_type test -snes_test_display. The FAQs mention that some troubleshooting tools are more useful for small test problems. How small is small? > > > > > > > > Tiny, at most a few dozen rows and columns in the Jacobin. > > > > > > > > You should run without the -snes_test_display information, what does it say? Does it indicate the Jacobian or report there is likely a problem? > > > > > > > > With DMDA you can also use -snes_fd_color to have PETSc compute the Jacobian for you instead of using your analytical form. If it works with this, but not your Jacobian then your Jacobian is wrong. > > > > > > > > > When I try to run the program with -snes_type test -snes_test_display, I get errors like: > > > > > > > > > > [0]PETSC ERROR: Argument out of range [0]PETSC ERROR: Local index 1076396032 too large 4979879 (max) at 0 > > > > > > > > > > The second size is 1 less than the number of field elements, while the first number seems too large for any aspect of the problem - the Jacobian has at most 59 non-zero columns per row. > > > > > > > > > > Because I suspect a possible error in the Jacobian, I ran with -snes_mf_operator -pc_type ksp -ksp_ksp_rtol 1e-12 and observed very similar failure to converge (diverging residual) as with the explicit Jacobian. > > > > > > > > What do you get with -ksp_monitor -ksp_ksp_monitor it sounds like the true Jacobian is either very ill-conditioned or your function evaluation is wrong. > > > > > > > > > Do I need to set an SNES method which is somehow compatible with the "matrix-free" approach? If I instead use -snes_mf, the problem seems to converge, but horrendously slowly (true residual relative decrease by about 1e-5 per iteration). I suppose this supports my suspicion that the Jacobian is incorrect but doesn't really suggest a solution. > > > > > > > > > > Is it possible that the analytical Jacobian is correct, but somehow pathological, which causes the SNES to diverge? > > > > > > > > Yes > > > > > > > > > Neither the Jacobian nor the function have singularities. > > > > > > > > > > Thanks for any help you can provide! > > > > > > > > Try really hard to set up a small problem (like just use a very coarse grid) to experiment with as you try to get convergence. Using a big problem for debugging convergence is a recipe for pain. > > > > > > > > Also since you have a Jacobian I would start with -snes_fd_color -snes_type ls -snes_monitor -snes_linesearch_monitor -ksp_monitor -pc_type lu (not on a huge problem), what happens? Send the output > > > > > > > > Barry > > > > > > > > > > > > > > > > > > > > > > > > From zakaryah at gmail.com Sun Aug 27 18:19:52 2017 From: zakaryah at gmail.com (zakaryah .) Date: Sun, 27 Aug 2017 19:19:52 -0400 Subject: [petsc-users] A number of questions about DMDA with SNES and Quasi-Newton methods In-Reply-To: <08AA1273-062D-4FDD-8709-40AA1FE8AA92@mcs.anl.gov> References: <020DAED9-AAAD-4741-976B-BB2EF6C79D3F@mcs.anl.gov> <5BF530F6-8D79-47E6-B2C5-B0702FF2AA59@mcs.anl.gov> <7EE84495-4346-4BFB-B9AD-BCAA3C722461@mcs.anl.gov> <08AA1273-062D-4FDD-8709-40AA1FE8AA92@mcs.anl.gov> Message-ID: Heh, I guess it's at least a sign that the two fd methods agreed. This takes me back to my earlier question - when I call MatSetOption(jac,MAT_NEW_ NONZERO_LOCATION_ERR,PETSC_FALSE), what is jac? Do I need to preallocate it? Do I need to get it from the SNES? Do I need to set that matrix as the SNES Jacobian? Do I allocate the actual number of non-zero rows, or the entirety of the stencil? I notice that -snes_test_display reports values for the entire stencil, even though of the 27 points in the stencil, only 19 can be non-zero. On Sun, Aug 27, 2017 at 5:51 PM, Barry Smith wrote: > > Sorry this a flaw with the current release. Call > > MatSetOption(jac,MAT_NEW_NONZERO_LOCATION_ERR,PETSC_FALSE) > > before the call to the solver. > > > > On Aug 27, 2017, at 12:54 PM, zakaryah . wrote: > > > > Is it suspicious that the KSP converges so quickly? I have no > experience with how the solvers behave on such small grids. > > > > Also, I ran the code with -snes_type test on a very small grid (1530 > elements). The simpler version of the PDE ran fine, and showed good > agreement of the matrices. However, the more complicated version crashes > with the following errors: > > > > Testing hand-coded Jacobian, if the ratio is > > > > O(1.e-8), the hand-coded Jacobian is probably correct. > > > > Run with -snes_test_display to show difference > > > > of hand-coded and finite difference Jacobian. > > > > [0]PETSC ERROR: --------------------- Error Message > -------------------------------------------------------------- > > > > [0]PETSC ERROR: Argument out of range > > > > [0]PETSC ERROR: Inserting a new nonzero at (7,0) in the matrix > > > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html > for trouble shooting. > > > > [0]PETSC ERROR: Petsc Release Version 3.7.3, Jul, 24, 2016 > > > > [0]PETSC ERROR: #1 MatSetValues_SeqAIJ() line 484 in path>/PETSc/build/petsc-3.7.3/src/mat/impls/aij/seq/aij.c > > > > [0]PETSC ERROR: #2 MatSetValues() line 1190 in path>/PETSc/build/petsc-3.7.3/src/mat/interface/matrix.c > > > > [0]PETSC ERROR: #3 MatSetValuesLocal() line 2053 in path>/PETSc/build/petsc-3.7.3/src/mat/interface/matrix.c > > > > [0]PETSC ERROR: #4 MatSetValuesStencil() line 1447 in path>/PETSc/build/petsc-3.7.3/src/mat/interface/matrix.c > > > > Does this indicate a bug in the Jacobian calculation? I don't think I > set values outside of the stencil... > > > > > > On Sun, Aug 27, 2017 at 12:14 AM, zakaryah . wrote: > > Sure - it was this: > > > > mpiexec -n 1 -snes_fd_color -snes_type > newtonls -snes_monitor -snes_linesearch_monitor -ksp_monitor -pc_type lu > > > > On Sun, Aug 27, 2017 at 12:11 AM, Barry Smith > wrote: > > > > > On Aug 26, 2017, at 10:55 PM, zakaryah . wrote: > > > > > > Yes, except I changed "-snes_type ls" to "-snes_type newtonls" because > PETSc complained that ls wasn't a known method. > > > > Sorry, my memory is not as good as it used to be; but what other > options did you use? Send the exact command line. > > > > > > Barry > > ' > > > > > > On Sat, Aug 26, 2017 at 11:52 PM, Barry Smith > wrote: > > > > > > My exact options did you run with? > > > > > > > On Aug 26, 2017, at 10:48 PM, zakaryah . wrote: > > > > > > > > Here's the output, from the data set which does not converge with > l-bfgs: > > > > > > > > 0 SNES Function norm 1.370293318432e+04 > > > > 0 KSP Residual norm 7.457506389218e+02 > > > > 1 KSP Residual norm 2.244764079994e-10 > > > > Line search: gnorm after quadratic fit 6.541298279196e+05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 8.963717927372e+04 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.788909416707e+04 lambda=2.5000000000000001e-02 > > > > Line search: Cubically determined step, current gnorm > 1.340565762719e+04 lambda=1.2500000000000001e-02 > > > > 1 SNES Function norm 1.340565762719e+04 > > > > 0 KSP Residual norm 4.096066553372e+02 > > > > 1 KSP Residual norm 3.313671167444e-11 > > > > Line search: gnorm after quadratic fit 1.113749573695e+06 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.406390140546e+05 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.126781917443e+04 lambda=2.5000000000000001e-02 > > > > Line search: Cubically determined step, current gnorm > 1.272988597973e+04 lambda=1.2500000000000001e-02 > > > > 2 SNES Function norm 1.272988597973e+04 > > > > 0 KSP Residual norm 8.291344597817e+01 > > > > 1 KSP Residual norm 7.182258362182e-12 > > > > Line search: gnorm after quadratic fit 1.121913743889e+04 > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > 3 SNES Function norm 1.121913743889e+04 > > > > 0 KSP Residual norm 6.830535877014e+01 > > > > 1 KSP Residual norm 3.629826411580e-12 > > > > Line search: gnorm after quadratic fit 9.966344973786e+03 > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > 4 SNES Function norm 9.966344973786e+03 > > > > 0 KSP Residual norm 5.137691531345e+01 > > > > 1 KSP Residual norm 1.954502098181e-12 > > > > Line search: gnorm after quadratic fit 8.905508641232e+03 > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > 5 SNES Function norm 8.905508641232e+03 > > > > 0 KSP Residual norm 4.295019262963e+01 > > > > 1 KSP Residual norm 1.581527994925e-12 > > > > Line search: gnorm after quadratic fit 7.599173694189e+03 > > > > Line search: Quadratically determined step, > lambda=1.4157226463489950e-01 > > > > 6 SNES Function norm 7.599173694189e+03 > > > > 0 KSP Residual norm 3.520472291520e+01 > > > > 1 KSP Residual norm 1.169994130568e-12 > > > > Line search: gnorm after quadratic fit 6.797214843928e+03 > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > 7 SNES Function norm 6.797214843928e+03 > > > > 0 KSP Residual norm 2.683523206056e+01 > > > > 1 KSP Residual norm 9.039858014119e-13 > > > > Line search: gnorm after quadratic fit 6.098038917364e+03 > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > 8 SNES Function norm 6.098038917364e+03 > > > > 0 KSP Residual norm 2.300710560681e+01 > > > > 1 KSP Residual norm 1.010402303464e-12 > > > > Line search: gnorm after quadratic fit 5.486151385552e+03 > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > 9 SNES Function norm 5.486151385552e+03 > > > > 0 KSP Residual norm 2.824628827619e+01 > > > > 1 KSP Residual norm 1.009589866569e-12 > > > > Line search: gnorm after quadratic fit 4.964991021247e+03 > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > 10 SNES Function norm 4.964991021247e+03 > > > > 0 KSP Residual norm 6.285926028595e+01 > > > > 1 KSP Residual norm 2.833546214180e-12 > > > > Line search: gnorm after quadratic fit 2.100041391472e+04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.804051080767e+03 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm > 4.893296169579e+03 lambda=2.5000000000000001e-02 > > > > 11 SNES Function norm 4.893296169579e+03 > > > > 0 KSP Residual norm 1.688978282804e+01 > > > > 1 KSP Residual norm 5.927677470786e-13 > > > > Line search: gnorm after quadratic fit 4.400894622431e+03 > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > 12 SNES Function norm 4.400894622431e+03 > > > > 0 KSP Residual norm 1.481197699600e+01 > > > > 1 KSP Residual norm 4.522572128105e-13 > > > > Line search: Using full step: fnorm 4.400894622431e+03 gnorm > 2.094971849007e+03 > > > > 13 SNES Function norm 2.094971849007e+03 > > > > 0 KSP Residual norm 3.514164563318e+00 > > > > 1 KSP Residual norm 3.022385947499e-13 > > > > Line search: gnorm after quadratic fit 1.687641025382e+03 > > > > Line search: Quadratically determined step, > lambda=2.0307116693368590e-01 > > > > 14 SNES Function norm 1.687641025382e+03 > > > > 0 KSP Residual norm 2.138591884686e+00 > > > > 1 KSP Residual norm 4.023500814078e-14 > > > > Line search: Using full step: fnorm 1.687641025382e+03 gnorm > 1.131934218470e+03 > > > > 15 SNES Function norm 1.131934218470e+03 > > > > 0 KSP Residual norm 3.245035110327e+00 > > > > 1 KSP Residual norm 1.293626215269e-13 > > > > Line search: Using full step: fnorm 1.131934218470e+03 gnorm > 7.340573607307e+02 > > > > 16 SNES Function norm 7.340573607307e+02 > > > > 0 KSP Residual norm 1.957698957904e+00 > > > > 1 KSP Residual norm 3.444648967078e-13 > > > > Line search: Using full step: fnorm 7.340573607307e+02 gnorm > 5.024723505168e+02 > > > > 17 SNES Function norm 5.024723505168e+02 > > > > 0 KSP Residual norm 2.510538703839e+00 > > > > 1 KSP Residual norm 8.570440675253e-14 > > > > Line search: gnorm after quadratic fit 4.548776456608e+02 > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > 18 SNES Function norm 4.548776456608e+02 > > > > 0 KSP Residual norm 6.741705718178e-01 > > > > 1 KSP Residual norm 1.650556120809e-14 > > > > Line search: Using full step: fnorm 4.548776456608e+02 gnorm > 1.351189086642e+02 > > > > 19 SNES Function norm 1.351189086642e+02 > > > > 0 KSP Residual norm 7.653741241950e+00 > > > > 1 KSP Residual norm 8.326848236950e-14 > > > > Line search: gnorm after quadratic fit 4.215455105006e+02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.889750369356e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.358691836999e+02 lambda=1.0303015930243279e-02 > > > > Line search: Cubically determined step, current gnorm > 1.348911963390e+02 lambda=3.5279526770504110e-03 > > > > 20 SNES Function norm 1.348911963390e+02 > > > > 0 KSP Residual norm 4.209281176918e+00 > > > > 1 KSP Residual norm 1.233232881375e-13 > > > > Line search: gnorm after quadratic fit 1.860023264470e+02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.413911132196e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm > 1.339597869053e+02 lambda=1.5787957598629023e-02 > > > > 21 SNES Function norm 1.339597869053e+02 > > > > 0 KSP Residual norm 1.718484765841e+00 > > > > 1 KSP Residual norm 6.666016296543e-14 > > > > Line search: gnorm after quadratic fit 1.326878521472e+02 > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > 22 SNES Function norm 1.326878521472e+02 > > > > 0 KSP Residual norm 1.515373499919e+00 > > > > 1 KSP Residual norm 2.259154130795e-12 > > > > Line search: gnorm after quadratic fit 1.226907316391e+02 > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > 23 SNES Function norm 1.226907316391e+02 > > > > 0 KSP Residual norm 1.080252936903e+00 > > > > 1 KSP Residual norm 1.847020526683e-14 > > > > Line search: gnorm after quadratic fit 1.163632111851e+02 > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > 24 SNES Function norm 1.163632111851e+02 > > > > 0 KSP Residual norm 2.491746958382e+00 > > > > 1 KSP Residual norm 6.389134193637e-14 > > > > Line search: gnorm after quadratic fit 1.345487153563e+02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.169738363622e+02 lambda=4.4108900954515480e-02 > > > > Line search: Cubically determined step, current gnorm > 1.152177638108e+02 lambda=1.9997442889243631e-02 > > > > 25 SNES Function norm 1.152177638108e+02 > > > > 0 KSP Residual norm 5.364385501004e+00 > > > > 1 KSP Residual norm 8.457149562463e-14 > > > > Line search: gnorm after quadratic fit 2.722095758964e+02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.480946353374e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm > 1.150680255994e+02 lambda=6.3560128131639167e-03 > > > > 26 SNES Function norm 1.150680255994e+02 > > > > 0 KSP Residual norm 4.302025268263e+00 > > > > 1 KSP Residual norm 1.017526937941e-13 > > > > Line search: gnorm after quadratic fit 1.956300983573e+02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.318600522939e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm > 1.147123505014e+02 lambda=7.6060788653548803e-03 > > > > 27 SNES Function norm 1.147123505014e+02 > > > > 0 KSP Residual norm 6.195463111324e+00 > > > > 1 KSP Residual norm 1.235283250361e-13 > > > > Line search: gnorm after quadratic fit 3.324821547049e+02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.612593208504e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.147389525772e+02 lambda=6.1750939181374294e-03 > > > > Line search: Cubically determined step, current gnorm > 1.145411432123e+02 lambda=3.0078592586792975e-03 > > > > 28 SNES Function norm 1.145411432123e+02 > > > > 0 KSP Residual norm 1.454704250187e+01 > > > > 1 KSP Residual norm 2.368485174123e-13 > > > > Line search: gnorm after quadratic fit 1.216293873116e+03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.796524621727e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.359314163651e+02 lambda=1.4867675803955788e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.146009802557e+02 lambda=1.4867675803955788e-03 > > > > Line search: Cubically determined step, current gnorm > 1.145096815033e+02 lambda=5.5250912472932839e-04 > > > > 29 SNES Function norm 1.145096815033e+02 > > > > 0 KSP Residual norm 3.430451345093e+01 > > > > 1 KSP Residual norm 1.069396165938e-12 > > > > Line search: gnorm after quadratic fit 1.161329407098e+04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.260690718050e+03 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.696806489042e+02 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.960149915648e+02 lambda=1.1276129246469476e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.158113641658e+02 lambda=1.5873910451430554e-03 > > > > Line search: Cubically determined step, current gnorm > 1.145062232916e+02 lambda=1.5873910451430555e-04 > > > > 30 SNES Function norm 1.145062232916e+02 > > > > 0 KSP Residual norm 2.662578971526e+01 > > > > 1 KSP Residual norm 5.464011789728e-13 > > > > Line search: gnorm after quadratic fit 4.375119254490e+03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.038018103928e+03 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.169328002874e+02 lambda=2.3789161387159519e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.262835432714e+02 lambda=5.9737415571960795e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.145626045197e+02 lambda=5.9737415571960802e-04 > > > > Line search: Cubically determined step, current gnorm > 1.144968604079e+02 lambda=1.6421773527706333e-04 > > > > 31 SNES Function norm 1.144968604079e+02 > > > > 0 KSP Residual norm 6.322033697338e+01 > > > > 1 KSP Residual norm 1.507157991448e-12 > > > > Line search: gnorm after quadratic fit 5.809243699277e+04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 9.460487584142e+03 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.893183483197e+03 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.960337007072e+02 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.771527792790e+02 lambda=5.3912931685137378e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.150137639707e+02 lambda=5.3912931685137376e-04 > > > > Line search: Cubically determined step, current gnorm > 1.144964484571e+02 lambda=5.3912931685137380e-05 > > > > 32 SNES Function norm 1.144964484571e+02 > > > > 0 KSP Residual norm 3.859510930996e+01 > > > > 1 KSP Residual norm 8.069118044382e-13 > > > > Line search: gnorm after quadratic fit 1.106329930525e+04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.155884463041e+03 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.933963819094e+02 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.849629797377e+02 lambda=9.7744286136270241e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.150857687050e+02 lambda=9.7744286136270254e-04 > > > > Line search: Cubically determined step, current gnorm > 1.144922906340e+02 lambda=9.7744286136270254e-05 > > > > 33 SNES Function norm 1.144922906340e+02 > > > > 0 KSP Residual norm 4.952038022394e+01 > > > > 1 KSP Residual norm 7.460263245424e-13 > > > > Line search: gnorm after quadratic fit 3.005091127220e+04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.229308416025e+03 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.138600794682e+03 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.390856262238e+02 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.394997214983e+02 lambda=4.4582997750629580e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.146836358799e+02 lambda=4.4582997750629581e-04 > > > > Line search: Cubically determined step, current gnorm > 1.144895966587e+02 lambda=4.7644082443915877e-05 > > > > 34 SNES Function norm 1.144895966587e+02 > > > > 0 KSP Residual norm 1.146914786457e+02 > > > > 1 KSP Residual norm 4.791627042400e-12 > > > > Line search: gnorm after quadratic fit 2.601294145944e+05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.324148513778e+04 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.247478406023e+03 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.200340900661e+03 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.696223112300e+02 lambda=6.1514413845115794e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.342365431983e+02 lambda=1.7502929694284564e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.146686063035e+02 lambda=1.7502929694284566e-04 > > > > Line search: Cubically determined step, current gnorm > 1.144895868489e+02 lambda=1.7502929694284566e-05 > > > > 35 SNES Function norm 1.144895868489e+02 > > > > 0 KSP Residual norm 6.311017209658e+01 > > > > 1 KSP Residual norm 8.384445939117e-13 > > > > Line search: gnorm after quadratic fit 5.781533400572e+04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 9.419557746031e+03 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.886081770030e+03 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.945810143740e+02 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.767820854837e+02 lambda=5.3859001959289735e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.150034040559e+02 lambda=5.3859001959289732e-04 > > > > Line search: Cubically determined step, current gnorm > 1.144891501665e+02 lambda=5.3859001959289732e-05 > > > > 36 SNES Function norm 1.144891501665e+02 > > > > 0 KSP Residual norm 3.880748384332e+01 > > > > 1 KSP Residual norm 6.400339290453e-13 > > > > Line search: gnorm after quadratic fit 1.122504184426e+04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.180728237366e+03 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.987870621566e+02 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.863711604331e+02 lambda=9.8150771384688824e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.150916783781e+02 lambda=9.8150771384688824e-04 > > > > Line search: Cubically determined step, current gnorm > 1.144850837411e+02 lambda=9.8150771384688832e-05 > > > > 37 SNES Function norm 1.144850837411e+02 > > > > 0 KSP Residual norm 4.811537498557e+01 > > > > 1 KSP Residual norm 9.738167670242e-13 > > > > Line search: gnorm after quadratic fit 2.784098355218e+04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.885118868254e+03 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.074843354348e+03 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.255202820836e+02 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.365202996130e+02 lambda=4.3204204582016374e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.146504919412e+02 lambda=4.3204204582016374e-04 > > > > Line search: Cubically determined step, current gnorm > 1.144822306241e+02 lambda=5.0376546850227848e-05 > > > > 38 SNES Function norm 1.144822306241e+02 > > > > 0 KSP Residual norm 1.120914002482e+02 > > > > 1 KSP Residual norm 5.452125292284e-12 > > > > Line search: gnorm after quadratic fit 2.427186680567e+05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.112196656857e+04 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.967397366072e+03 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.149551659770e+03 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.529630886791e+02 lambda=6.0885216927030559e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.315267519231e+02 lambda=1.6656233536183130e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.146353659250e+02 lambda=1.6656233536183130e-04 > > > > Line search: Cubically determined step, current gnorm > 1.144820487391e+02 lambda=1.6656233536183130e-05 > > > > 39 SNES Function norm 1.144820487391e+02 > > > > 0 KSP Residual norm 7.182416170980e+01 > > > > 1 KSP Residual norm 1.292147133333e-12 > > > > Line search: gnorm after quadratic fit 8.255331293322e+04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.302939895170e+04 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.501228089911e+03 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.185010378583e+02 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.088179821424e+02 lambda=5.7489510178867142e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.168272901121e+02 lambda=9.7452649444612811e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.144951972300e+02 lambda=9.7452649444612822e-05 > > > > Line search: Cubically determined step, current gnorm > 1.144807676687e+02 lambda=2.2399506502463798e-05 > > > > 40 SNES Function norm 1.144807676687e+02 > > > > 0 KSP Residual norm 1.728679810285e+02 > > > > 1 KSP Residual norm 3.878068639716e-12 > > > > Line search: gnorm after quadratic fit 9.011020578535e+05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.111818830011e+05 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.504789858103e+04 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.754312133162e+03 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 7.212492111975e+02 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.199969180537e+02 lambda=2.6424184504193135e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.154794639440e+02 lambda=2.6424184504193136e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.144880673342e+02 lambda=2.6424184504193136e-05 > > > > Line search: Cubically determined step, current gnorm > 1.144805461570e+02 lambda=3.8712107591125690e-06 > > > > 41 SNES Function norm 1.144805461570e+02 > > > > 0 KSP Residual norm 4.162780846202e+02 > > > > 1 KSP Residual norm 1.732341544934e-11 > > > > Line search: gnorm after quadratic fit 1.355673864369e+07 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.747523002884e+06 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.342205048417e+05 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.425635699680e+04 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.882150659178e+03 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.259664786336e+03 lambda=3.1250000000000002e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.653670676209e+02 lambda=1.5625000000000001e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.453655830144e+02 lambda=5.8237455565260388e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.147659525018e+02 lambda=5.8237455565260393e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.144827915995e+02 lambda=5.8237455565260400e-06 > > > > Line search: Cubically determined step, current gnorm > 1.144805080017e+02 lambda=6.6689295146509104e-07 > > > > 42 SNES Function norm 1.144805080017e+02 > > > > 0 KSP Residual norm 1.004135512581e+03 > > > > 1 KSP Residual norm 3.867626041000e-09 > > > > Line search: gnorm after quadratic fit 1.832578994882e+08 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.269698278878e+07 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.792476589915e+06 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.420660371083e+05 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.321686926168e+04 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.548358078234e+03 lambda=3.1250000000000002e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.429504802276e+03 lambda=1.5625000000000001e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.317723385004e+02 lambda=7.8125000000000004e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.460079723095e+02 lambda=2.5078917343692407e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.147908977725e+02 lambda=2.5078917343692408e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.144833604238e+02 lambda=2.5078917343692412e-06 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.144805106824e+02 lambda=2.5078917343692411e-07 > > > > Line search: Cubically determined step, current gnorm > 1.144805014337e+02 lambda=1.1468707119027746e-07 > > > > 43 SNES Function norm 1.144805014337e+02 > > > > 0 KSP Residual norm 2.418614573592e+03 > > > > 1 KSP Residual norm 6.085078742847e-10 > > > > Line search: gnorm after quadratic fit 2.598476259775e+09 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.262759415873e+08 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.116845970403e+07 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.250465130250e+06 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.863493884574e+05 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 9.501468163771e+04 lambda=3.1250000000000002e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.482658980483e+04 lambda=1.5625000000000001e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.802395557883e+03 lambda=7.8125000000000004e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.788149582374e+02 lambda=3.9062500000000002e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.248828337038e+02 lambda=1.8333058767960295e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.186285836222e+02 lambda=3.7550993478654105e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.145209710139e+02 lambda=3.7550993478654107e-06 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.144808670668e+02 lambda=3.7550993478654111e-07 > > > > Line search: Cubically determined step, current gnorm > 1.144805012252e+02 lambda=3.7550993478654114e-08 > > > > 44 SNES Function norm 1.144805012252e+02 > > > > 0 KSP Residual norm 1.432476672735e+03 > > > > 1 KSP Residual norm 7.850524783892e-11 > > > > Line search: gnorm after quadratic fit 5.336191593632e+08 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.625576866625e+07 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 8.181408387845e+06 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.003310644422e+06 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.236384273292e+05 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.658430638069e+04 lambda=3.1250000000000002e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.977463068161e+03 lambda=1.5625000000000001e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 7.674238499253e+02 lambda=7.8125000000000004e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.333616820791e+02 lambda=3.3764776729281175e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.161349153752e+02 lambda=4.0497161764116874e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.144966925969e+02 lambda=4.0497161764116874e-06 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.144806214839e+02 lambda=4.0497161764116878e-07 > > > > Line search: Cubically determined step, current gnorm > 1.144804979966e+02 lambda=5.6339112427782378e-08 > > > > 45 SNES Function norm 1.144804979966e+02 > > > > 0 KSP Residual norm 3.453401579761e+03 > > > > 1 KSP Residual norm 4.197968028126e-09 > > > > Line search: gnorm after quadratic fit 7.554006183767e+09 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 9.471974940372e+08 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.191613865049e+08 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.509784334249e+07 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.943752478560e+06 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.597601716755e+05 lambda=3.1250000000000002e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.775572331075e+04 lambda=1.5625000000000001e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.418045407608e+03 lambda=7.8125000000000004e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.357066758731e+03 lambda=3.9062500000000002e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.859267839080e+02 lambda=1.9531250000000001e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.501494912160e+02 lambda=7.5160826909319168e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.148144926477e+02 lambda=7.5160826909319171e-06 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.144837498478e+02 lambda=7.5160826909319179e-07 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.144805227746e+02 lambda=7.5160826909319182e-08 > > > > Line search: Cubically determined step, current gnorm > 1.144804974438e+02 lambda=9.6864021663644795e-09 > > > > 46 SNES Function norm 1.144804974438e+02 > > > > 0 KSP Residual norm 8.345139428850e+03 > > > > 1 KSP Residual norm 1.027819754739e-09 > > > > Line search: gnorm after quadratic fit 1.061319903906e+11 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.325012985379e+10 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.652236226640e+09 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.055533971630e+08 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.546607716763e+07 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.134442858835e+06 lambda=3.1250000000000002e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.839168570687e+05 lambda=1.5625000000000001e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.830568178626e+04 lambda=7.8125000000000004e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 7.201776786081e+03 lambda=3.9062500000000002e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.540520468013e+03 lambda=1.9531250000000001e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.573504890506e+02 lambda=9.7656250000000005e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.516203908013e+02 lambda=3.2703670177372021e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.148480075676e+02 lambda=3.2703670177372022e-06 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.144841475328e+02 lambda=3.2703670177372023e-07 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.144805305720e+02 lambda=3.2703670177372021e-08 > > > > Line search: Cubically determined step, current gnorm > 1.144804974367e+02 lambda=3.2703670177372025e-09 > > > > 47 SNES Function norm 1.144804974367e+02 > > > > 0 KSP Residual norm 4.668983500382e+03 > > > > 1 KSP Residual norm 1.398997665317e-09 > > > > Line search: gnorm after quadratic fit 1.865309565532e+10 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.336975299727e+09 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.934905088739e+08 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.704520478641e+07 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.728477809448e+06 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.193001670096e+05 lambda=3.1250000000000002e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 8.610673238239e+04 lambda=1.5625000000000001e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.354711683605e+04 lambda=7.8125000000000004e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.589557246433e+03 lambda=3.9062500000000002e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.367851970709e+02 lambda=1.9531250000000001e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.136930269795e+02 lambda=9.0316845802227864e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.172186635069e+02 lambda=1.5831613287181393e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.145074017254e+02 lambda=1.5831613287181394e-06 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.144807499816e+02 lambda=1.5831613287181396e-07 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.144804983345e+02 lambda=1.5831613287181397e-08 > > > > Line search: Cubically determined step, current gnorm > 1.144804971346e+02 lambda=5.2932921109871310e-09 > > > > 48 SNES Function norm 1.144804971346e+02 > > > > 0 KSP Residual norm 1.132678078317e+04 > > > > 1 KSP Residual norm 2.477518733314e-10 > > > > Line search: gnorm after quadratic fit 2.654659022365e+11 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.315296223725e+10 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.136635677074e+09 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.152507060235e+08 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.397060094478e+07 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 7.898362012287e+06 lambda=3.1250000000000002e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 9.685179520906e+05 lambda=1.5625000000000001e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.194040779842e+05 lambda=7.8125000000000004e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.606415730227e+04 lambda=3.9062500000000002e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.902698091972e+03 lambda=1.9531250000000001e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 7.521549384652e+02 lambda=9.7656250000000005e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.288999778994e+02 lambda=4.1899746703195281e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.157880829786e+02 lambda=4.5470218451893824e-06 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.144935741206e+02 lambda=4.5470218451893828e-07 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.144806232638e+02 lambda=4.5470218451893831e-08 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.144804979250e+02 lambda=4.5470218451893835e-09 > > > > Line search: Cubically determined step, current gnorm > 1.144804970825e+02 lambda=9.0293679903918216e-10 > > > > 49 SNES Function norm 1.144804970825e+02 > > > > 0 KSP Residual norm 2.712544829144e+04 > > > > 1 KSP Residual norm 4.949246309677e-09 > > > > Line search: gnorm after quadratic fit 3.650846005745e+12 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.565321055911e+11 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.711080201118e+10 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 7.150022242308e+09 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 8.965954117985e+08 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.128096393645e+08 lambda=3.1250000000000002e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.429702091584e+07 lambda=1.5625000000000001e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.841819946536e+06 lambda=7.8125000000000004e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.465032956946e+05 lambda=3.9062500000000002e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.594210253794e+04 lambda=1.9531250000000001e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.141110278944e+03 lambda=9.7656250000000005e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.306952279045e+03 lambda=4.8828125000000003e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.754164864338e+02 lambda=2.4414062500000001e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.476861367158e+02 lambda=9.2451761406722810e-06 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.147929263780e+02 lambda=9.2451761406722810e-07 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.144836022952e+02 lambda=9.2451761406722821e-08 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.144805271860e+02 lambda=9.2451761406722831e-09 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.144804972895e+02 lambda=9.2451761406722839e-10 > > > > Line search: Cubically determined step, current gnorm > 1.144804970737e+02 lambda=1.5633616333063305e-10 > > > > 50 SNES Function norm 1.144804970737e+02 > > > > 0 SNES Function norm 2.308693894796e+03 > > > > 0 KSP Residual norm 8.981999720532e+00 > > > > 1 KSP Residual norm 2.363170936183e-13 > > > > Line search: Using full step: fnorm 2.308693894796e+03 gnorm > 7.571661187318e+02 > > > > 1 SNES Function norm 7.571661187318e+02 > > > > 0 KSP Residual norm 2.149614048903e+00 > > > > 1 KSP Residual norm 9.511247057888e-13 > > > > Line search: Using full step: fnorm 7.571661187318e+02 gnorm > 4.450081004997e+02 > > > > 2 SNES Function norm 4.450081004997e+02 > > > > 0 KSP Residual norm 1.706469075123e+01 > > > > 1 KSP Residual norm 5.803815175472e-13 > > > > Line search: gnorm after quadratic fit 1.510518198899e+03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.850796532980e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.515983139755e+02 lambda=2.0602556887689423e-02 > > > > Line search: Cubically determined step, current gnorm > 4.434800867235e+02 lambda=8.2396279492937211e-03 > > > > 3 SNES Function norm 4.434800867235e+02 > > > > 0 KSP Residual norm 3.208587171626e+00 > > > > 1 KSP Residual norm 1.099072610659e-13 > > > > Line search: gnorm after quadratic fit 4.080637194736e+02 > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > 4 SNES Function norm 4.080637194736e+02 > > > > 0 KSP Residual norm 8.136557176540e+00 > > > > 1 KSP Residual norm 8.800137844173e-13 > > > > Line search: gnorm after quadratic fit 5.261656549654e+02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.131114070934e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm > 4.031614746044e+02 lambda=2.4674842039461482e-02 > > > > 5 SNES Function norm 4.031614746044e+02 > > > > 0 KSP Residual norm 7.609918907567e+00 > > > > 1 KSP Residual norm 1.613159932655e-13 > > > > Line search: gnorm after quadratic fit 5.353908064984e+02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.110480554132e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm > 3.991168240716e+02 lambda=2.3079500036735322e-02 > > > > 6 SNES Function norm 3.991168240716e+02 > > > > 0 KSP Residual norm 3.800845472041e+00 > > > > 1 KSP Residual norm 4.841682188278e-13 > > > > Line search: gnorm after quadratic fit 3.787886582952e+02 > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > 7 SNES Function norm 3.787886582952e+02 > > > > 0 KSP Residual norm 1.892621919219e+00 > > > > 1 KSP Residual norm 3.576655371800e-12 > > > > Line search: gnorm after quadratic fit 3.440181918909e+02 > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > 8 SNES Function norm 3.440181918909e+02 > > > > 0 KSP Residual norm 3.559759789147e+00 > > > > 1 KSP Residual norm 8.347521826622e-13 > > > > Line search: gnorm after quadratic fit 3.287993515195e+02 > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > 9 SNES Function norm 3.287993515195e+02 > > > > 0 KSP Residual norm 1.825073540507e+00 > > > > 1 KSP Residual norm 8.352745008123e-14 > > > > Line search: Using full step: fnorm 3.287993515195e+02 gnorm > 2.710650507416e+02 > > > > 10 SNES Function norm 2.710650507416e+02 > > > > 0 KSP Residual norm 7.568432945608e-01 > > > > 1 KSP Residual norm 2.780715252274e-14 > > > > Line search: Using full step: fnorm 2.710650507416e+02 gnorm > 1.513359047342e+02 > > > > 11 SNES Function norm 1.513359047342e+02 > > > > 0 KSP Residual norm 9.387460484575e+00 > > > > 1 KSP Residual norm 7.091233040676e-13 > > > > Line search: gnorm after quadratic fit 3.998857979851e+02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.060972049714e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm > 1.512140169420e+02 lambda=5.4338709720680610e-03 > > > > 12 SNES Function norm 1.512140169420e+02 > > > > 0 KSP Residual norm 4.399424360499e+00 > > > > 1 KSP Residual norm 1.614362118182e-13 > > > > Line search: gnorm after quadratic fit 1.913552832643e+02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.559719302467e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm > 1.499985374733e+02 lambda=1.7102027220313589e-02 > > > > 13 SNES Function norm 1.499985374733e+02 > > > > 0 KSP Residual norm 3.740397849742e+00 > > > > 1 KSP Residual norm 8.986775577006e-13 > > > > Line search: gnorm after quadratic fit 1.764118876632e+02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.522381536119e+02 lambda=4.8196830215713270e-02 > > > > Line search: Cubically determined step, current gnorm > 1.486175880390e+02 lambda=1.8881300948189364e-02 > > > > 14 SNES Function norm 1.486175880390e+02 > > > > 0 KSP Residual norm 6.067973818528e+00 > > > > 1 KSP Residual norm 4.527845229549e-13 > > > > Line search: gnorm after quadratic fit 2.514021299115e+02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.679972156573e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm > 1.481015724304e+02 lambda=9.0116621678703428e-03 > > > > 15 SNES Function norm 1.481015724304e+02 > > > > 0 KSP Residual norm 6.108754994263e+00 > > > > 1 KSP Residual norm 2.557635976440e-13 > > > > Line search: gnorm after quadratic fit 2.458081150104e+02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.681837029397e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm > 1.476148340442e+02 lambda=7.9580911933571953e-03 > > > > 16 SNES Function norm 1.476148340442e+02 > > > > 0 KSP Residual norm 7.914946163932e+00 > > > > 1 KSP Residual norm 1.512066885699e-13 > > > > Line search: gnorm after quadratic fit 3.458938604598e+02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.883018868359e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm > 1.474286108114e+02 lambda=6.7262521208543979e-03 > > > > 17 SNES Function norm 1.474286108114e+02 > > > > 0 KSP Residual norm 5.285449532689e+00 > > > > 1 KSP Residual norm 6.693733977456e-12 > > > > Line search: gnorm after quadratic fit 2.170263102661e+02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.607560548008e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm > 1.467785507822e+02 lambda=9.9244383205188240e-03 > > > > 18 SNES Function norm 1.467785507822e+02 > > > > 0 KSP Residual norm 8.124903695635e+00 > > > > 1 KSP Residual norm 2.322439601127e-11 > > > > Line search: gnorm after quadratic fit 3.589716592364e+02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.907315184877e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm > 1.466341888638e+02 lambda=6.5538271222582893e-03 > > > > 19 SNES Function norm 1.466341888638e+02 > > > > 0 KSP Residual norm 5.253550718343e+00 > > > > 1 KSP Residual norm 1.575657996883e-12 > > > > Line search: gnorm after quadratic fit 2.155795776725e+02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.598564001687e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm > 1.459869404602e+02 lambda=9.9195822632931301e-03 > > > > 20 SNES Function norm 1.459869404602e+02 > > > > 0 KSP Residual norm 8.405987790193e+00 > > > > 1 KSP Residual norm 2.046159481178e-13 > > > > Line search: gnorm after quadratic fit 3.767908298426e+02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.941885062002e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm > 1.458995232755e+02 lambda=6.4359684554015136e-03 > > > > 21 SNES Function norm 1.458995232755e+02 > > > > 0 KSP Residual norm 5.036348246593e+00 > > > > 1 KSP Residual norm 3.645081669075e-13 > > > > Line search: gnorm after quadratic fit 2.083222977519e+02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.575737508694e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm > 1.452039802458e+02 lambda=1.0554092389542354e-02 > > > > 22 SNES Function norm 1.452039802458e+02 > > > > 0 KSP Residual norm 8.562292355998e+00 > > > > 1 KSP Residual norm 3.256332645483e-13 > > > > Line search: gnorm after quadratic fit 3.869470823355e+02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.959483128249e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm > 1.451523830598e+02 lambda=6.3780526507799607e-03 > > > > 23 SNES Function norm 1.451523830598e+02 > > > > 0 KSP Residual norm 4.919667503862e+00 > > > > 1 KSP Residual norm 4.823931177115e-13 > > > > Line search: gnorm after quadratic fit 2.042891039525e+02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.560623102934e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm > 1.444331916523e+02 lambda=1.0890355421223689e-02 > > > > 24 SNES Function norm 1.444331916523e+02 > > > > 0 KSP Residual norm 8.727282395369e+00 > > > > 1 KSP Residual norm 7.090683582186e-13 > > > > Line search: gnorm after quadratic fit 3.977929422821e+02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.978556223200e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm > 1.444215965394e+02 lambda=6.3477766966048947e-03 > > > > 25 SNES Function norm 1.444215965394e+02 > > > > 0 KSP Residual norm 4.759732971179e+00 > > > > 1 KSP Residual norm 7.539889498211e-13 > > > > Line search: gnorm after quadratic fit 1.990589649135e+02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.542648241555e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm > 1.436629416941e+02 lambda=1.1434720389464151e-02 > > > > 26 SNES Function norm 1.436629416941e+02 > > > > 0 KSP Residual norm 8.844861828477e+00 > > > > 1 KSP Residual norm 4.372001279689e-13 > > > > Line search: gnorm after quadratic fit 4.055598972133e+02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.990820671396e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.436827663113e+02 lambda=6.3302081701296859e-03 > > > > Line search: Cubically determined step, current gnorm > 1.434397789472e+02 lambda=3.1285674619640730e-03 > > > > 27 SNES Function norm 1.434397789472e+02 > > > > 0 KSP Residual norm 2.168630760128e+01 > > > > 1 KSP Residual norm 3.975838928402e-13 > > > > Line search: gnorm after quadratic fit 1.655681371309e+03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.972331169594e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.804118272840e+02 lambda=1.6710557456633125e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.435928635079e+02 lambda=1.6710557456633126e-03 > > > > Line search: Cubically determined step, current gnorm > 1.434032742903e+02 lambda=5.1357350159978810e-04 > > > > 28 SNES Function norm 1.434032742903e+02 > > > > 0 KSP Residual norm 5.259508821923e+01 > > > > 1 KSP Residual norm 1.358381204928e-11 > > > > Line search: gnorm after quadratic fit 1.908330224731e+04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.431279702545e+03 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 8.060945045253e+02 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.791318323447e+02 lambda=1.2124172979783788e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.491140019897e+02 lambda=2.6952165802905347e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.434246250245e+02 lambda=2.6952165802905350e-04 > > > > Line search: Cubically determined step, current gnorm > 1.433970449422e+02 lambda=8.6980371578986910e-05 > > > > 29 SNES Function norm 1.433970449422e+02 > > > > 0 KSP Residual norm 1.326287161615e+02 > > > > 1 KSP Residual norm 5.692176796134e-12 > > > > Line search: gnorm after quadratic fit 2.077891749832e+05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.654187989332e+04 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.213029457851e+03 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.001385334742e+03 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.323976827250e+02 lambda=5.9607661619885998e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.489839529892e+02 lambda=1.0476257410701045e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.434396736634e+02 lambda=1.0476257410701046e-04 > > > > Line search: Cubically determined step, current gnorm > 1.433960671821e+02 lambda=1.3664867646895530e-05 > > > > 30 SNES Function norm 1.433960671821e+02 > > > > 0 KSP Residual norm 3.320710360189e+02 > > > > 1 KSP Residual norm 1.365660123102e-11 > > > > Line search: gnorm after quadratic fit 3.597335441013e+06 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.714766420450e+05 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.566809766217e+04 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.038660363150e+04 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.026997416957e+03 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.382653551072e+02 lambda=3.1250000000000002e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.071747386385e+02 lambda=1.3384948046761360e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.439693866777e+02 lambda=1.3384948046761360e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.434000505249e+02 lambda=1.3384948046761361e-05 > > > > Line search: Cubically determined step, current gnorm > 1.433959111179e+02 lambda=2.1771867000079373e-06 > > > > 31 SNES Function norm 1.433959111179e+02 > > > > 0 KSP Residual norm 8.385024273664e+02 > > > > 1 KSP Residual norm 2.688330817732e-11 > > > > Line search: gnorm after quadratic fit 5.487352481970e+07 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.776642694838e+06 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 8.310551423141e+05 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.023322644608e+05 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.368662233379e+04 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.472194884015e+03 lambda=3.1250000000000002e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.718801059897e+02 lambda=1.5625000000000001e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.274234972424e+02 lambda=6.3064412238487922e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.442194384053e+02 lambda=6.3064412238487925e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.434033578642e+02 lambda=6.3064412238487927e-06 > > > > Line search: Cubically determined step, current gnorm > 1.433959042208e+02 lambda=6.3064412238487929e-07 > > > > 32 SNES Function norm 1.433959042208e+02 > > > > 0 KSP Residual norm 5.310191626867e+02 > > > > 1 KSP Residual norm 2.270033897601e-10 > > > > Line search: gnorm after quadratic fit 1.447633783740e+07 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.859761774309e+06 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.472992503503e+05 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.557594026810e+04 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.969012939380e+03 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.269212161982e+03 lambda=3.1250000000000002e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.859005100842e+02 lambda=1.5625000000000001e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.695095262046e+02 lambda=5.4509037994531233e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.436389958907e+02 lambda=5.4509037994531237e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.433976258223e+02 lambda=5.4509037994531242e-06 > > > > Line search: Cubically determined step, current gnorm > 1.433958431980e+02 lambda=8.5124820362933632e-07 > > > > 33 SNES Function norm 1.433958431980e+02 > > > > 0 KSP Residual norm 1.341142541825e+03 > > > > 1 KSP Residual norm 4.194815344365e-11 > > > > Line search: gnorm after quadratic fit 2.256410317099e+08 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.797696259877e+07 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.447237377751e+06 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.221898175722e+05 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.260244723327e+04 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 7.539148524881e+03 lambda=3.1250000000000002e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.558034531173e+03 lambda=1.5625000000000001e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.788188892302e+02 lambda=7.8125000000000004e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.753621043454e+02 lambda=2.4427125599600652e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.437122397600e+02 lambda=2.4427125599600654e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.433986985128e+02 lambda=2.4427125599600655e-06 > > > > Line search: Cubically determined step, current gnorm > 1.433958402293e+02 lambda=2.4427125599600656e-07 > > > > 34 SNES Function norm 1.433958402293e+02 > > > > 0 KSP Residual norm 8.620962950418e+02 > > > > 1 KSP Residual norm 4.517777375659e-11 > > > > Line search: gnorm after quadratic fit 6.134442313460e+07 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 7.790495969255e+06 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.008365220843e+06 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.364572513478e+05 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.037891335918e+04 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.640571521199e+03 lambda=3.1250000000000002e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 8.472549649319e+02 lambda=1.5625000000000001e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.906041216274e+02 lambda=7.6348458761785112e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.504925859329e+02 lambda=1.7740973415567094e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.434632637071e+02 lambda=1.7740973415567094e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.433962847027e+02 lambda=1.7740973415567095e-06 > > > > Line search: Cubically determined step, current gnorm > 1.433958170795e+02 lambda=3.2293255704969003e-07 > > > > 35 SNES Function norm 1.433958170795e+02 > > > > 0 KSP Residual norm 2.177497039945e+03 > > > > 1 KSP Residual norm 8.546235181505e-11 > > > > Line search: gnorm after quadratic fit 9.689178330938e+08 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.204850731541e+08 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.491460480376e+07 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.833699292784e+06 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.246639021599e+05 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.860166571872e+04 lambda=3.1250000000000002e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.484329051490e+03 lambda=1.5625000000000001e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.050411687443e+03 lambda=7.8125000000000004e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.488366972009e+02 lambda=3.7767265396089055e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.508326035050e+02 lambda=7.2725649346261757e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.434696063559e+02 lambda=7.2725649346261764e-06 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.433964618996e+02 lambda=7.2725649346261768e-07 > > > > Line search: Cubically determined step, current gnorm > 1.433958141405e+02 lambda=7.2725649346261771e-08 > > > > 36 SNES Function norm 1.433958141405e+02 > > > > 0 KSP Residual norm 2.164813477994e+03 > > > > 1 KSP Residual norm 1.148881458292e-10 > > > > Line search: gnorm after quadratic fit 9.626940870744e+08 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.210459267934e+08 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.531855101756e+07 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.966826097072e+06 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.611808255272e+05 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.746062783262e+04 lambda=3.1250000000000002e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.252259871244e+03 lambda=1.5625000000000001e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.319447372021e+03 lambda=7.8125000000000004e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.963055448218e+02 lambda=3.9062500000000002e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.719034797105e+02 lambda=1.3935000445038475e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.436664111092e+02 lambda=1.3935000445038476e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.433983336239e+02 lambda=1.3935000445038476e-06 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.433958213497e+02 lambda=1.3935000445038476e-07 > > > > Line search: Cubically determined step, current gnorm > 1.433958104705e+02 lambda=5.1202466521517630e-08 > > > > 37 SNES Function norm 1.433958104705e+02 > > > > 0 KSP Residual norm 5.470482746849e+03 > > > > 1 KSP Residual norm 2.077456833170e-10 > > > > Line search: gnorm after quadratic fit 1.541335606193e+10 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.922526157954e+09 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.393079394383e+08 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.967573549050e+07 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.657319925168e+06 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.479516204895e+05 lambda=3.1250000000000002e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.573399122917e+04 lambda=1.5625000000000001e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 7.931177424479e+03 lambda=7.8125000000000004e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.619710606187e+03 lambda=3.9062500000000002e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.924551713717e+02 lambda=1.9531250000000001e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.786095404459e+02 lambda=6.2808469554243522e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.437467476469e+02 lambda=6.2808469554243527e-06 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.433992463439e+02 lambda=6.2808469554243527e-07 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.433958367271e+02 lambda=6.2808469554243525e-08 > > > > Line search: Cubically determined step, current gnorm > 1.433958098948e+02 lambda=8.0208105170108588e-09 > > > > 38 SNES Function norm 1.433958098948e+02 > > > > 0 KSP Residual norm 1.380568582849e+04 > > > > 1 KSP Residual norm 3.830866223513e-10 > > > > Line search: gnorm after quadratic fit 2.484973518314e+11 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.108953896984e+10 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.893104137528e+09 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.884003910853e+08 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.150765563542e+07 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 7.811161146103e+06 lambda=3.1250000000000002e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.011017986781e+06 lambda=1.5625000000000001e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.368084343451e+05 lambda=7.8125000000000004e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.042876665700e+04 lambda=3.9062500000000002e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.648735196752e+03 lambda=1.9531250000000001e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 8.489051252413e+02 lambda=9.7656250000000005e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.910677756717e+02 lambda=4.7728537787817724e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.505452645186e+02 lambda=1.1099980464343249e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.434658984864e+02 lambda=1.1099980464343249e-06 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.433964956476e+02 lambda=1.1099980464343249e-07 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.433958153212e+02 lambda=1.1099980464343250e-08 > > > > Line search: Cubically determined step, current gnorm > 1.433958098048e+02 lambda=1.2587012037197021e-09 > > > > 39 SNES Function norm 1.433958098048e+02 > > > > 0 KSP Residual norm 3.492284741552e+04 > > > > 1 KSP Residual norm 2.459788921244e-09 > > > > Line search: gnorm after quadratic fit 4.017424324975e+12 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.020053801097e+11 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.270768402853e+10 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 7.827801904036e+09 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 9.758550488105e+08 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.213492627852e+08 lambda=3.1250000000000002e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.502191365805e+07 lambda=1.5625000000000001e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.846947104704e+06 lambda=7.8125000000000004e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.262850216093e+05 lambda=3.9062500000000002e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.879926646684e+04 lambda=1.9531250000000001e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.510203332079e+03 lambda=9.7656250000000005e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.055028679619e+03 lambda=4.8828125000000003e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.503903269554e+02 lambda=2.3633949212111800e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.510245991472e+02 lambda=4.5897967908360529e-06 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.434724062782e+02 lambda=4.5897967908360533e-07 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.433965706606e+02 lambda=4.5897967908360533e-08 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.433958168196e+02 lambda=4.5897967908360538e-09 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.433958098155e+02 lambda=4.5897967908360540e-10 > > > > Line search: Cubically determined step, current gnorm > 1.433958097906e+02 lambda=1.9745369723997599e-10 > > > > 40 SNES Function norm 1.433958097906e+02 > > > > 0 KSP Residual norm 8.722495521587e+04 > > > > 1 KSP Residual norm 3.742695919275e-09 > > > > Line search: gnorm after quadratic fit 6.262538457180e+13 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 7.829256308992e+12 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 9.789282877890e+11 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.224340679566e+11 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.532137613500e+10 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.919506047737e+09 lambda=3.1250000000000002e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.410488718338e+08 lambda=1.5625000000000001e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.042211373104e+07 lambda=7.8125000000000004e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.881986305609e+06 lambda=3.9062500000000002e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.080857001861e+05 lambda=1.9531250000000001e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 7.054449734307e+04 lambda=9.7656250000000005e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.109051581397e+04 lambda=4.8828125000000003e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.144985497099e+03 lambda=2.4414062500000001e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.617627947761e+02 lambda=1.2207031250000001e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.132828960986e+02 lambda=5.3137869181552773e-06 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.440403409760e+02 lambda=5.3137869181552777e-07 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.434022226216e+02 lambda=5.3137869181552781e-08 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.433958732177e+02 lambda=5.3137869181552781e-09 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.433958103569e+02 lambda=5.3137869181552779e-10 > > > > Line search: Cubically determined step, current gnorm > 1.433958097894e+02 lambda=5.3137869181552781e-11 > > > > 41 SNES Function norm 1.433958097894e+02 > > > > 0 KSP Residual norm 6.453169081212e+04 > > > > 1 KSP Residual norm 2.762540688686e-09 > > > > Line search: gnorm after quadratic fit 2.535166112592e+13 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.168366990040e+12 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.958985371462e+11 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.945064622488e+10 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.172244865713e+09 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 7.693002384290e+08 lambda=3.1250000000000002e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 9.562568994785e+07 lambda=1.5625000000000001e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.182957296890e+07 lambda=7.8125000000000004e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.453260254263e+06 lambda=3.9062500000000002e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.781984147743e+05 lambda=1.9531250000000001e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.294934468515e+04 lambda=9.7656250000000005e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.740461720782e+03 lambda=4.8828125000000003e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 9.162621855154e+02 lambda=2.4414062500000001e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.042417294890e+02 lambda=1.1290474210136388e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.458920680477e+02 lambda=1.4201366604660443e-06 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.434208620254e+02 lambda=1.4201366604660444e-07 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.433960586269e+02 lambda=1.4201366604660445e-08 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.433958120934e+02 lambda=1.4201366604660445e-09 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.433958097940e+02 lambda=1.4201366604660446e-10 > > > > Line search: Cubically determined step, current gnorm > 1.433958097852e+02 lambda=5.7981795207229486e-11 > > > > 42 SNES Function norm 1.433958097852e+02 > > > > 0 KSP Residual norm 1.596625793747e+05 > > > > 1 KSP Residual norm 6.465899717071e-09 > > > > Line search: gnorm after quadratic fit 3.840699863976e+14 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.801237514773e+13 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.002454410823e+12 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 7.505340831651e+11 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 9.387378188418e+10 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.174857842415e+10 lambda=3.1250000000000002e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.472211181784e+09 lambda=1.5625000000000001e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.849608933788e+08 lambda=7.8125000000000004e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.336592011613e+07 lambda=3.9062500000000002e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.988079805895e+06 lambda=1.9531250000000001e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.930858080425e+05 lambda=9.7656250000000005e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.521190722497e+04 lambda=4.8828125000000003e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 8.872153015323e+03 lambda=2.4414062500000001e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.772337662956e+03 lambda=1.2207031250000001e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.879470852054e+02 lambda=6.1035156250000003e-06 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.942774855488e+02 lambda=2.4957912736226801e-06 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.438719078958e+02 lambda=2.4957912736226800e-07 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.434005516391e+02 lambda=2.4957912736226800e-08 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.433958568732e+02 lambda=2.4957912736226803e-09 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.433958102244e+02 lambda=2.4957912736226804e-10 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.433958097865e+02 lambda=2.4957912736226805e-11 > > > > Line search: Cubically determined step, current gnorm > 1.433958097846e+02 lambda=9.2900433293108317e-12 > > > > 43 SNES Function norm 1.433958097846e+02 > > > > 0 KSP Residual norm 4.230869747157e+05 > > > > 1 KSP Residual norm 2.238707423027e-08 > > > > Line search: gnorm after quadratic fit 7.145700515048e+15 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 8.931871281700e+14 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.116420341041e+14 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.395366610168e+13 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.743811756566e+12 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.178776103292e+11 lambda=3.1250000000000002e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.721012032848e+10 lambda=1.5625000000000001e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.395186924428e+09 lambda=7.8125000000000004e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.229125978585e+08 lambda=3.9062500000000002e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.250971135953e+07 lambda=1.9531250000000001e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.483856203094e+06 lambda=9.7656250000000005e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 7.950671355228e+05 lambda=4.8828125000000003e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 9.795408218555e+04 lambda=2.4414062500000001e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.315025696280e+04 lambda=1.2207031250000001e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.395961070555e+03 lambda=6.1035156250000003e-06 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.565070307576e+02 lambda=3.0517578125000002e-06 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.228949713871e+02 lambda=1.2154989071946628e-06 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.441831998014e+02 lambda=1.2154989071946629e-07 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.434037055996e+02 lambda=1.2154989071946630e-08 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.433958886074e+02 lambda=1.2154989071946630e-09 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.433958105564e+02 lambda=1.2154989071946630e-10 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.433958097907e+02 lambda=1.2154989071946631e-11 > > > > Line search: Cubically determined step, current gnorm > 1.433958097845e+02 lambda=1.3559489351735629e-12 > > > > 44 SNES Function norm 1.433958097845e+02 > > > > 0 KSP Residual norm 1.017589039922e+06 > > > > 1 KSP Residual norm 5.483283808994e-08 > > > > Line search: gnorm after quadratic fit 9.942386816509e+16 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.242813073279e+16 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.553553149772e+15 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.942033483320e+14 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.427772097758e+13 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.035291372732e+12 lambda=3.1250000000000002e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.795558047824e+11 lambda=1.5625000000000001e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.748073147307e+10 lambda=7.8125000000000004e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.944235240368e+09 lambda=3.9062500000000002e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 7.453550734860e+08 lambda=1.9531250000000001e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 9.377045707707e+07 lambda=9.7656250000000005e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.188119937132e+07 lambda=4.8828125000000003e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.529730353136e+06 lambda=2.4414062500000001e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.044646611329e+05 lambda=1.2207031250000001e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.974477616118e+04 lambda=6.1035156250000003e-06 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.087923877078e+03 lambda=3.0517578125000002e-06 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.112257173311e+03 lambda=1.5258789062500001e-06 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.536190077033e+02 lambda=7.6293945312500004e-07 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.622567424729e+02 lambda=2.4244966960965791e-07 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.435780438142e+02 lambda=2.4244966960965793e-08 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.433976282603e+02 lambda=2.4244966960965796e-09 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.433958279382e+02 lambda=2.4244966960965797e-10 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.433958099632e+02 lambda=2.4244966960965799e-11 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.433958097860e+02 lambda=2.4244966960965801e-12 > > > > Line search: Cubically determined step, current gnorm > 1.433958097845e+02 lambda=2.4244966960965801e-13 > > > > 45 SNES Function norm 1.433958097845e+02 > > > > 0 KSP Residual norm 2.206687220910e+06 > > > > 1 KSP Residual norm 4.897651438902e-08 > > > > Line search: gnorm after quadratic fit 1.013883843512e+18 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.267347883019e+17 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.584167551460e+16 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.980166189110e+15 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.475099638694e+14 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.093604443378e+13 lambda=3.1250000000000002e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.866330988164e+12 lambda=1.5625000000000001e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.831230804145e+11 lambda=7.8125000000000004e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.034848618023e+10 lambda=3.9062500000000002e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 7.533173457427e+09 lambda=1.9531250000000001e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 9.390937545910e+08 lambda=9.7656250000000005e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.167706366282e+08 lambda=4.8828125000000003e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.445357932595e+07 lambda=2.4414062500000001e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.776833600920e+06 lambda=1.2207031250000001e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.177171496134e+05 lambda=6.1035156250000003e-06 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.775750596740e+04 lambda=3.0517578125000002e-06 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.374283858049e+03 lambda=1.5258789062500001e-06 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.030949543491e+03 lambda=7.6293945312500004e-07 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.423064811256e+02 lambda=3.6673216108643130e-07 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.499924205417e+02 lambda=6.7541706529544844e-08 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.434620968378e+02 lambda=6.7541706529544851e-09 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.433964732224e+02 lambda=6.7541706529544853e-10 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.433958164087e+02 lambda=6.7541706529544856e-11 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.433958098496e+02 lambda=6.7541706529544860e-12 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.433958097850e+02 lambda=6.7541706529544869e-13 > > > > Line search: unable to find good step length! After 24 tries > > > > Line search: fnorm=1.4339580978447020e+02, > gnorm=1.4339580978501337e+02, ynorm=2.2066872446260620e+06, > minlambda=9.9999999999999998e-13, lambda=6.7541706529544869e-13, initial > slope=-2.0562359199040133e+04 > > > > 0 SNES Function norm 7.494832241120e+03 > > > > 0 KSP Residual norm 2.096735360816e+01 > > > > 1 KSP Residual norm 1.310027756820e-12 > > > > Line search: gnorm after quadratic fit 6.728375857515e+03 > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > 1 SNES Function norm 6.728375857515e+03 > > > > 0 KSP Residual norm 2.051806116405e+01 > > > > 1 KSP Residual norm 4.624620138831e-13 > > > > Line search: gnorm after quadratic fit 6.028616261650e+03 > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > 2 SNES Function norm 6.028616261650e+03 > > > > 0 KSP Residual norm 2.416503160016e+01 > > > > 1 KSP Residual norm 8.456041680630e-13 > > > > Line search: gnorm after quadratic fit 5.407473517447e+03 > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > 3 SNES Function norm 5.407473517447e+03 > > > > 0 KSP Residual norm 1.429873750399e+01 > > > > 1 KSP Residual norm 2.956316145819e-13 > > > > Line search: Using full step: fnorm 5.407473517447e+03 gnorm > 1.894530516076e+03 > > > > 4 SNES Function norm 1.894530516076e+03 > > > > 0 KSP Residual norm 2.898580554597e+00 > > > > 1 KSP Residual norm 6.622560162623e-14 > > > > Line search: Using full step: fnorm 1.894530516076e+03 gnorm > 1.794029421846e+03 > > > > 5 SNES Function norm 1.794029421846e+03 > > > > 0 KSP Residual norm 1.749678611959e+01 > > > > 1 KSP Residual norm 8.138905825078e-12 > > > > Line search: gnorm after quadratic fit 1.767361408940e+03 > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > 6 SNES Function norm 1.767361408940e+03 > > > > 0 KSP Residual norm 1.094404109423e+02 > > > > 1 KSP Residual norm 7.696691527700e-12 > > > > Line search: gnorm after quadratic fit 3.545750923895e+04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.153479540314e+03 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.205683629874e+03 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.802976525485e+03 lambda=1.2441094586006883e-02 > > > > Line search: Cubically determined step, current gnorm > 1.765063299263e+03 lambda=4.9240328094708914e-03 > > > > 7 SNES Function norm 1.765063299263e+03 > > > > 0 KSP Residual norm 1.778095975189e+01 > > > > 1 KSP Residual norm 2.814661813934e-12 > > > > Line search: gnorm after quadratic fit 2.620761680117e+03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.793045753271e+03 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm > 1.740299227935e+03 lambda=2.5000000000000001e-02 > > > > 8 SNES Function norm 1.740299227935e+03 > > > > 0 KSP Residual norm 3.284236894535e+02 > > > > 1 KSP Residual norm 5.172103783952e-10 > > > > Line search: gnorm after quadratic fit 2.857820523902e+05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.063993491139e+04 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 7.588139591650e+03 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.491163684413e+03 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.802614760566e+03 lambda=5.7977212395253904e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.741444490992e+03 lambda=1.8448315876950813e-03 > > > > Line search: Cubically determined step, current gnorm > 1.739663656043e+03 lambda=7.7468345598227730e-04 > > > > 9 SNES Function norm 1.739663656043e+03 > > > > 0 KSP Residual norm 4.581839103558e+02 > > > > 1 KSP Residual norm 2.627035885943e-11 > > > > Line search: gnorm after quadratic fit 8.199478499066e+05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.127270076812e+05 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.816774161281e+04 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.053723877333e+03 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.971814513392e+03 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.755066208174e+03 lambda=2.7232010924558834e-03 > > > > Line search: Cubically determined step, current gnorm > 1.739559834479e+03 lambda=8.1458417855297680e-04 > > > > 10 SNES Function norm 1.739559834479e+03 > > > > 0 KSP Residual norm 1.463056810139e+02 > > > > 1 KSP Residual norm 5.383584598825e-12 > > > > Line search: gnorm after quadratic fit 2.885699620595e+04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.847717401708e+03 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.244464170034e+03 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.769157604338e+03 lambda=1.0857209099577540e-02 > > > > Line search: Cubically determined step, current gnorm > 1.737356225452e+03 lambda=4.0312937622950231e-03 > > > > 11 SNES Function norm 1.737356225452e+03 > > > > 0 KSP Residual norm 1.564105677925e+02 > > > > 1 KSP Residual norm 6.671164745832e-11 > > > > Line search: gnorm after quadratic fit 3.815800291873e+04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 7.197027796134e+03 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.373151605545e+03 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.783976520867e+03 lambda=1.2093374970461970e-02 > > > > Line search: Cubically determined step, current gnorm > 1.735737929915e+03 lambda=4.9529698477569920e-03 > > > > 12 SNES Function norm 1.735737929915e+03 > > > > 0 KSP Residual norm 5.030757139645e+01 > > > > 1 KSP Residual norm 1.157542730692e-12 > > > > Line search: gnorm after quadratic fit 3.004544441458e+03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.850403239750e+03 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm > 1.722893188305e+03 lambda=2.0881992439921702e-02 > > > > 13 SNES Function norm 1.722893188305e+03 > > > > 0 KSP Residual norm 7.123428853845e+01 > > > > 1 KSP Residual norm 8.671726774894e-12 > > > > Line search: gnorm after quadratic fit 4.361041499279e+03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.032697222107e+03 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.726212330814e+03 lambda=1.9909470348267504e-02 > > > > Line search: Cubically determined step, current gnorm > 1.714127356920e+03 lambda=9.9547351741337518e-03 > > > > 14 SNES Function norm 1.714127356920e+03 > > > > 0 KSP Residual norm 8.304557447257e+00 > > > > 1 KSP Residual norm 6.268295862688e-13 > > > > Line search: gnorm after quadratic fit 1.558163002487e+03 > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > 15 SNES Function norm 1.558163002487e+03 > > > > 0 KSP Residual norm 2.820803287164e+00 > > > > 1 KSP Residual norm 5.477413853752e-13 > > > > Line search: gnorm after quadratic fit 1.065673478530e+03 > > > > Line search: Quadratically determined step, > lambda=3.8943438938591052e-01 > > > > 16 SNES Function norm 1.065673478530e+03 > > > > 0 KSP Residual norm 2.296739120664e+00 > > > > 1 KSP Residual norm 6.273731899885e-14 > > > > Line search: gnorm after quadratic fit 8.964342150621e+02 > > > > Line search: Quadratically determined step, > lambda=1.8740736900935545e-01 > > > > 17 SNES Function norm 8.964342150621e+02 > > > > 0 KSP Residual norm 5.567568505830e+00 > > > > 1 KSP Residual norm 8.649083600764e-12 > > > > Line search: gnorm after quadratic fit 8.322514858992e+02 > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > 18 SNES Function norm 8.322514858992e+02 > > > > 0 KSP Residual norm 1.164393577210e+00 > > > > 1 KSP Residual norm 2.019248309015e-14 > > > > Line search: Using full step: fnorm 8.322514858992e+02 gnorm > 3.179750274746e+02 > > > > 19 SNES Function norm 3.179750274746e+02 > > > > 0 KSP Residual norm 5.339294310641e+00 > > > > 1 KSP Residual norm 2.070321587238e-13 > > > > Line search: gnorm after quadratic fit 3.433012316833e+02 > > > > Line search: Cubically determined step, current gnorm > 3.140305403821e+02 lambda=5.0000000000000003e-02 > > > > 20 SNES Function norm 3.140305403821e+02 > > > > 0 KSP Residual norm 1.177016565578e+01 > > > > 1 KSP Residual norm 2.413027540446e-13 > > > > Line search: gnorm after quadratic fit 7.377851778409e+02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.896721016582e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm > 3.136619309181e+02 lambda=9.7219892278716195e-03 > > > > 21 SNES Function norm 3.136619309181e+02 > > > > 0 KSP Residual norm 3.973565083977e+00 > > > > 1 KSP Residual norm 9.726786674410e-14 > > > > Line search: gnorm after quadratic fit 3.098277326090e+02 > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > 22 SNES Function norm 3.098277326090e+02 > > > > 0 KSP Residual norm 9.389290683519e+00 > > > > 1 KSP Residual norm 1.651497163724e-13 > > > > Line search: gnorm after quadratic fit 6.887970540455e+02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.588146381477e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.099274823603e+02 lambda=1.6890426151283184e-02 > > > > Line search: Cubically determined step, current gnorm > 3.084890760827e+02 lambda=8.4452130756415920e-03 > > > > 23 SNES Function norm 3.084890760827e+02 > > > > 0 KSP Residual norm 2.381130479641e+00 > > > > 1 KSP Residual norm 4.694489283156e-14 > > > > Line search: gnorm after quadratic fit 2.872151876535e+02 > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > 24 SNES Function norm 2.872151876535e+02 > > > > 0 KSP Residual norm 2.405498502269e+00 > > > > 1 KSP Residual norm 3.316846070538e-13 > > > > Line search: gnorm after quadratic fit 2.686789761232e+02 > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > 25 SNES Function norm 2.686789761232e+02 > > > > 0 KSP Residual norm 1.728772970554e+00 > > > > 1 KSP Residual norm 4.132974383339e-14 > > > > Line search: gnorm after quadratic fit 2.365009918229e+02 > > > > Line search: Quadratically determined step, > lambda=1.7273357529379074e-01 > > > > 26 SNES Function norm 2.365009918229e+02 > > > > 0 KSP Residual norm 4.413764759374e+00 > > > > 1 KSP Residual norm 5.210690816917e-14 > > > > Line search: gnorm after quadratic fit 2.756730968257e+02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.372321757171e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm > 2.335020811250e+02 lambda=2.5000000000000001e-02 > > > > 27 SNES Function norm 2.335020811250e+02 > > > > 0 KSP Residual norm 1.606246507553e+00 > > > > 1 KSP Residual norm 3.564847846678e-14 > > > > Line search: gnorm after quadratic fit 2.078263630653e+02 > > > > Line search: Quadratically determined step, > lambda=1.5913860995949433e-01 > > > > 28 SNES Function norm 2.078263630653e+02 > > > > 0 KSP Residual norm 3.700632954873e+00 > > > > 1 KSP Residual norm 5.113863400264e-13 > > > > Line search: gnorm after quadratic fit 2.142503514807e+02 > > > > Line search: Cubically determined step, current gnorm > 2.021095009118e+02 lambda=5.0000000000000003e-02 > > > > 29 SNES Function norm 2.021095009118e+02 > > > > 0 KSP Residual norm 3.056449560135e+00 > > > > 1 KSP Residual norm 3.207987681334e-14 > > > > Line search: gnorm after quadratic fit 2.064252530802e+02 > > > > Line search: Cubically determined step, current gnorm > 1.978069081639e+02 lambda=5.0000000000000003e-02 > > > > 30 SNES Function norm 1.978069081639e+02 > > > > 0 KSP Residual norm 2.024695620703e+00 > > > > 1 KSP Residual norm 5.460360737995e-14 > > > > Line search: gnorm after quadratic fit 1.839556530796e+02 > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > 31 SNES Function norm 1.839556530796e+02 > > > > 0 KSP Residual norm 1.610676619931e+01 > > > > 1 KSP Residual norm 6.703552136307e-13 > > > > Line search: gnorm after quadratic fit 7.186735314913e+02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.905672430097e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.856766286600e+02 lambda=1.0830798014298563e-02 > > > > Line search: Cubically determined step, current gnorm > 1.836818937131e+02 lambda=3.3207362501459785e-03 > > > > 32 SNES Function norm 1.836818937131e+02 > > > > 0 KSP Residual norm 7.471722173131e+01 > > > > 1 KSP Residual norm 2.671534648829e-12 > > > > Line search: gnorm after quadratic fit 9.613379909411e+04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.509491298762e+04 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.808861367705e+03 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.767283758299e+02 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.665421328348e+02 lambda=6.0369453941238101e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.869726717041e+02 lambda=1.4394327006264963e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.836897704575e+02 lambda=1.4394327006264963e-04 > > > > Line search: Cubically determined step, current gnorm > 1.836767951408e+02 lambda=5.5567420418543164e-05 > > > > 33 SNES Function norm 1.836767951408e+02 > > > > 0 KSP Residual norm 2.702367712138e+01 > > > > 1 KSP Residual norm 2.731656687850e-12 > > > > Line search: gnorm after quadratic fit 3.331563146098e+03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 8.723694790688e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.941243220944e+02 lambda=2.1443568774664485e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.847231733910e+02 lambda=2.7571330376860012e-03 > > > > Line search: Cubically determined step, current gnorm > 1.836356729409e+02 lambda=4.7841280418270480e-04 > > > > 34 SNES Function norm 1.836356729409e+02 > > > > 0 KSP Residual norm 1.228333177997e+01 > > > > 1 KSP Residual norm 2.681127387880e-13 > > > > Line search: gnorm after quadratic fit 6.936329223475e+02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.749327218775e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.871557327742e+02 lambda=1.4160505301999991e-02 > > > > Line search: Cubically determined step, current gnorm > 1.833523080682e+02 lambda=3.5196326548579192e-03 > > > > 35 SNES Function norm 1.833523080682e+02 > > > > 0 KSP Residual norm 3.531886257396e+02 > > > > 1 KSP Residual norm 2.364634092895e-11 > > > > Line search: gnorm after quadratic fit 3.994783047929e+06 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.753715960726e+05 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.516669898185e+04 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.918985942348e+03 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.363599250418e+03 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.344906818752e+02 lambda=3.1250000000000002e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.991088183980e+02 lambda=1.0108094710462592e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.834621681844e+02 lambda=1.0108094710462593e-04 > > > > Line search: Cubically determined step, current gnorm > 1.833517377324e+02 lambda=1.0108094710462594e-05 > > > > 36 SNES Function norm 1.833517377324e+02 > > > > 0 KSP Residual norm 9.005833507118e+01 > > > > 1 KSP Residual norm 6.116387880629e-12 > > > > Line search: gnorm after quadratic fit 8.899847103226e+04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.388111536526e+04 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.532652074749e+03 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.864912734009e+02 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.421068789960e+02 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.873498120960e+02 lambda=2.1924025345283278e-03 > > > > Line search: Cubically determined step, current gnorm > 1.833506987706e+02 lambda=2.1924025345283280e-04 > > > > 37 SNES Function norm 1.833506987706e+02 > > > > 0 KSP Residual norm 1.548426525207e+01 > > > > 1 KSP Residual norm 1.038038773942e-12 > > > > Line search: gnorm after quadratic fit 6.702848665441e+02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.789880616078e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.846521504351e+02 lambda=1.0567302644323170e-02 > > > > Line search: Cubically determined step, current gnorm > 1.830548481815e+02 lambda=3.5274490352771972e-03 > > > > 38 SNES Function norm 1.830548481815e+02 > > > > 0 KSP Residual norm 1.523095478807e+01 > > > > 1 KSP Residual norm 1.963823596119e-12 > > > > Line search: gnorm after quadratic fit 9.255727478491e+02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.496757253461e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.863126241242e+02 lambda=9.3143291632966311e-03 > > > > Line search: Cubically determined step, current gnorm > 1.829091761403e+02 lambda=1.8107234819462800e-03 > > > > 39 SNES Function norm 1.829091761403e+02 > > > > 0 KSP Residual norm 1.311320726934e+01 > > > > 1 KSP Residual norm 9.084170520902e-13 > > > > Line search: gnorm after quadratic fit 7.488610069188e+02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.691148243365e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.885558228772e+02 lambda=1.9439894235886539e-02 > > > > Line search: Cubically determined step, current gnorm > 1.825540619134e+02 lambda=5.4967824488704169e-03 > > > > 40 SNES Function norm 1.825540619134e+02 > > > > 0 KSP Residual norm 1.218635557505e+01 > > > > 1 KSP Residual norm 7.760485728617e-13 > > > > Line search: gnorm after quadratic fit 6.636453826807e+02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.880828006022e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.830493790584e+02 lambda=6.6234802648049863e-03 > > > > Line search: Cubically determined step, current gnorm > 1.823397545268e+02 lambda=2.4308217464828865e-03 > > > > 41 SNES Function norm 1.823397545268e+02 > > > > 0 KSP Residual norm 9.456543593865e+00 > > > > 1 KSP Residual norm 7.046593270309e-13 > > > > Line search: gnorm after quadratic fit 3.369769163110e+02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.105230957789e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm > 1.817897533119e+02 lambda=9.1612481372917148e-03 > > > > 42 SNES Function norm 1.817897533119e+02 > > > > 0 KSP Residual norm 7.290035145805e+00 > > > > 1 KSP Residual norm 3.198962158141e-12 > > > > Line search: gnorm after quadratic fit 2.858311567415e+02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.965004842981e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm > 1.808845577764e+02 lambda=1.3826421990147811e-02 > > > > 43 SNES Function norm 1.808845577764e+02 > > > > 0 KSP Residual norm 7.256785036157e+00 > > > > 1 KSP Residual norm 9.243179217625e-14 > > > > Line search: gnorm after quadratic fit 2.534388176390e+02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.916726818893e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm > 1.797953125543e+02 lambda=1.3677747819164022e-02 > > > > 44 SNES Function norm 1.797953125543e+02 > > > > 0 KSP Residual norm 1.716201096352e+01 > > > > 1 KSP Residual norm 2.701418800808e-13 > > > > Line search: gnorm after quadratic fit 1.331064301474e+03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.461842246267e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.920668830294e+02 lambda=1.2856504859057132e-02 > > > > Line search: Cubically determined step, current gnorm > 1.797121460957e+02 lambda=1.4396611381500967e-03 > > > > 45 SNES Function norm 1.797121460957e+02 > > > > 0 KSP Residual norm 6.613432967985e+00 > > > > 1 KSP Residual norm 1.357752977076e-13 > > > > Line search: gnorm after quadratic fit 2.721288927858e+02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.939638282615e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm > 1.787985482018e+02 lambda=1.2647907914070569e-02 > > > > 46 SNES Function norm 1.787985482018e+02 > > > > 0 KSP Residual norm 1.225736349281e+01 > > > > 1 KSP Residual norm 3.819378790812e-13 > > > > Line search: gnorm after quadratic fit 4.548006065036e+02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.304803559060e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm > 1.787344729174e+02 lambda=8.9002284237256531e-03 > > > > 47 SNES Function norm 1.787344729174e+02 > > > > 0 KSP Residual norm 6.302465402340e+00 > > > > 1 KSP Residual norm 6.980931947122e-14 > > > > Line search: gnorm after quadratic fit 2.879477700004e+02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.980806946742e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm > 1.780128006935e+02 lambda=1.0223293444602008e-02 > > > > 48 SNES Function norm 1.780128006935e+02 > > > > 0 KSP Residual norm 4.323829277968e+00 > > > > 1 KSP Residual norm 5.223881369308e-13 > > > > Line search: gnorm after quadratic fit 1.957928151218e+02 > > > > Line search: Cubically determined step, current gnorm > 1.768899805640e+02 lambda=5.0000000000000003e-02 > > > > 49 SNES Function norm 1.768899805640e+02 > > > > 0 KSP Residual norm 2.249256107033e+00 > > > > 1 KSP Residual norm 3.624400957270e-14 > > > > Line search: gnorm after quadratic fit 1.704782114773e+02 > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > 50 SNES Function norm 1.704782114773e+02 > > > > 0 SNES Function norm 3.513783397332e+03 > > > > 0 KSP Residual norm 1.650214950648e+01 > > > > 1 KSP Residual norm 3.574269752690e-13 > > > > Line search: gnorm after quadratic fit 3.155830404050e+03 > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > 1 SNES Function norm 3.155830404050e+03 > > > > 0 KSP Residual norm 1.443734018042e+01 > > > > 1 KSP Residual norm 3.685565191058e-13 > > > > Line search: Using full step: fnorm 3.155830404050e+03 gnorm > 8.581212204155e+02 > > > > 2 SNES Function norm 8.581212204155e+02 > > > > 0 KSP Residual norm 2.492601775565e+00 > > > > 1 KSP Residual norm 9.698440210389e-14 > > > > Line search: Using full step: fnorm 8.581212204155e+02 gnorm > 7.018609898542e+02 > > > > 3 SNES Function norm 7.018609898542e+02 > > > > 0 KSP Residual norm 1.740320986421e+00 > > > > 1 KSP Residual norm 2.868780682435e-14 > > > > Line search: Using full step: fnorm 7.018609898542e+02 gnorm > 2.135824235887e+02 > > > > 4 SNES Function norm 2.135824235887e+02 > > > > 0 KSP Residual norm 1.647413497077e+00 > > > > 1 KSP Residual norm 2.731226225666e-14 > > > > Line search: gnorm after quadratic fit 1.936469032649e+02 > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > 5 SNES Function norm 1.936469032649e+02 > > > > 0 KSP Residual norm 1.406615972124e+00 > > > > 1 KSP Residual norm 3.167179626699e-14 > > > > Line search: gnorm after quadratic fit 1.755362571467e+02 > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > 6 SNES Function norm 1.755362571467e+02 > > > > 0 KSP Residual norm 1.480681706594e+00 > > > > 1 KSP Residual norm 2.935210968935e-14 > > > > Line search: gnorm after quadratic fit 1.597659506616e+02 > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > 7 SNES Function norm 1.597659506616e+02 > > > > 0 KSP Residual norm 4.013154698097e+00 > > > > 1 KSP Residual norm 1.021628704832e-13 > > > > Line search: gnorm after quadratic fit 1.728408060966e+02 > > > > Line search: Cubically determined step, current gnorm > 1.570815760721e+02 lambda=5.0000000000000003e-02 > > > > 8 SNES Function norm 1.570815760721e+02 > > > > 0 KSP Residual norm 1.510335662636e+00 > > > > 1 KSP Residual norm 2.728243244724e-14 > > > > Line search: gnorm after quadratic fit 1.450162880692e+02 > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > 9 SNES Function norm 1.450162880692e+02 > > > > 0 KSP Residual norm 1.923349271077e+01 > > > > 1 KSP Residual norm 1.640711956406e-11 > > > > Line search: gnorm after quadratic fit 1.016537223115e+03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.584263092048e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.490729346583e+02 lambda=9.3725990358703350e-03 > > > > Line search: Cubically determined step, current gnorm > 1.449349273006e+02 lambda=1.5464889706033082e-03 > > > > 10 SNES Function norm 1.449349273006e+02 > > > > 0 KSP Residual norm 1.154999084194e+01 > > > > 1 KSP Residual norm 1.292167633338e-11 > > > > Line search: gnorm after quadratic fit 6.060386918705e+02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.236630526035e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.491201927819e+02 lambda=1.6816056300124185e-02 > > > > Line search: Cubically determined step, current gnorm > 1.447023047013e+02 lambda=4.1484374564153808e-03 > > > > 11 SNES Function norm 1.447023047013e+02 > > > > 0 KSP Residual norm 7.278906180502e+00 > > > > 1 KSP Residual norm 2.815632651924e-12 > > > > Line search: gnorm after quadratic fit 2.512278711773e+02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.624350957814e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm > 1.441656049510e+02 lambda=1.0879389002513012e-02 > > > > 12 SNES Function norm 1.441656049510e+02 > > > > 0 KSP Residual norm 4.449836480267e+00 > > > > 1 KSP Residual norm 3.152365624813e-13 > > > > Line search: gnorm after quadratic fit 1.749680739878e+02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.458763435996e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm > 1.425715025152e+02 lambda=2.2766809271842225e-02 > > > > 13 SNES Function norm 1.425715025152e+02 > > > > 0 KSP Residual norm 4.218495037726e+00 > > > > 1 KSP Residual norm 1.398472536142e-12 > > > > Line search: gnorm after quadratic fit 1.645159536467e+02 > > > > Line search: Cubically determined step, current gnorm > 1.421991559212e+02 lambda=4.1883769431247941e-02 > > > > 14 SNES Function norm 1.421991559212e+02 > > > > 0 KSP Residual norm 1.968853538608e+00 > > > > 1 KSP Residual norm 7.594023450519e-12 > > > > Line search: gnorm after quadratic fit 1.350960142124e+02 > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > 15 SNES Function norm 1.350960142124e+02 > > > > 0 KSP Residual norm 3.444721686085e+00 > > > > 1 KSP Residual norm 5.312609674019e-14 > > > > Line search: gnorm after quadratic fit 1.472880565107e+02 > > > > Line search: Cubically determined step, current gnorm > 1.336714620145e+02 lambda=4.1341550820829437e-02 > > > > 16 SNES Function norm 1.336714620145e+02 > > > > 0 KSP Residual norm 3.276288899397e+00 > > > > 1 KSP Residual norm 8.394674946715e-14 > > > > Line search: gnorm after quadratic fit 1.459274497150e+02 > > > > Line search: Cubically determined step, current gnorm > 1.327618539486e+02 lambda=5.0000000000000003e-02 > > > > 17 SNES Function norm 1.327618539486e+02 > > > > 0 KSP Residual norm 2.630052244303e+00 > > > > 1 KSP Residual norm 4.351283410507e-14 > > > > Line search: gnorm after quadratic fit 1.350378060116e+02 > > > > Line search: Cubically determined step, current gnorm > 1.299403903934e+02 lambda=4.9913529436269283e-02 > > > > 18 SNES Function norm 1.299403903934e+02 > > > > 0 KSP Residual norm 6.124953430138e+00 > > > > 1 KSP Residual norm 2.295381352938e-13 > > > > Line search: gnorm after quadratic fit 2.275621676963e+02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.469611730657e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm > 1.294890694898e+02 lambda=1.0071939100661648e-02 > > > > 19 SNES Function norm 1.294890694898e+02 > > > > 0 KSP Residual norm 1.036733907011e+01 > > > > 1 KSP Residual norm 1.800941381283e-13 > > > > Line search: gnorm after quadratic fit 3.844879463595e+02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.875071148504e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm > 1.294494430642e+02 lambda=5.0000000000000010e-03 > > > > 20 SNES Function norm 1.294494430642e+02 > > > > 0 KSP Residual norm 8.224001595443e+00 > > > > 1 KSP Residual norm 3.337810156182e-13 > > > > Line search: gnorm after quadratic fit 3.332325263497e+02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.682441841234e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.294720538860e+02 lambda=8.5401597581228530e-03 > > > > Line search: Cubically determined step, current gnorm > 1.291762382985e+02 lambda=4.2555418164960989e-03 > > > > 21 SNES Function norm 1.291762382985e+02 > > > > 0 KSP Residual norm 3.920749219860e+01 > > > > 1 KSP Residual norm 1.610902886435e-12 > > > > Line search: gnorm after quadratic fit 3.472422440640e+03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.023065712859e+03 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.228184088700e+02 lambda=1.6004598823093592e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.298607525058e+02 lambda=1.6004598823093593e-03 > > > > Line search: Cubically determined step, current gnorm > 1.291643460998e+02 lambda=1.9319076533745672e-04 > > > > 22 SNES Function norm 1.291643460998e+02 > > > > 0 KSP Residual norm 1.520092314848e+02 > > > > 1 KSP Residual norm 7.089159192434e-11 > > > > Line search: gnorm after quadratic fit 2.752539686422e+05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.237188995536e+04 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 7.484370498858e+03 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.571039994484e+03 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.280898858362e+02 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.708927009106e+02 lambda=2.6114913411793973e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.294919567784e+02 lambda=2.6114913411793975e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.291645609810e+02 lambda=2.6114913411793977e-05 > > > > Line search: Cubically determined step, current gnorm > 1.291635530596e+02 lambda=1.2278773895355162e-05 > > > > 23 SNES Function norm 1.291635530596e+02 > > > > 0 KSP Residual norm 7.569206058965e+02 > > > > 1 KSP Residual norm 3.454693729751e-11 > > > > Line search: gnorm after quadratic fit 2.570888738395e+07 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.064965025187e+06 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.498514098182e+05 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.807487005202e+04 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.233167830543e+03 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.396736912757e+03 lambda=3.1250000000000002e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.547572543330e+02 lambda=1.2623406091699435e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.335889024473e+02 lambda=1.8542137907683829e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.292059042479e+02 lambda=1.8542137907683831e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.291637618568e+02 lambda=1.8542137907683832e-06 > > > > Line search: Cubically determined step, current gnorm > 1.291635210734e+02 lambda=4.9524172913414387e-07 > > > > 24 SNES Function norm 1.291635210734e+02 > > > > 0 KSP Residual norm 3.761913422861e+03 > > > > 1 KSP Residual norm 6.181718776929e-10 > > > > Line search: gnorm after quadratic fit 3.342370445037e+09 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.218326646111e+08 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.375128803204e+07 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.980626157021e+06 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 9.407418671219e+05 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.357321025399e+05 lambda=3.1250000000000002e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.188948059047e+04 lambda=1.5625000000000001e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.105117929713e+03 lambda=7.8125000000000004e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 9.331054736818e+02 lambda=3.9062500000000002e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.942479792843e+02 lambda=1.9412500272460620e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.436944624694e+02 lambda=6.4483223307578726e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.292972287211e+02 lambda=6.4483223307578726e-06 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.291647778160e+02 lambda=6.4483223307578730e-07 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.291635261433e+02 lambda=6.4483223307578730e-08 > > > > Line search: Cubically determined step, current gnorm > 1.291635197798e+02 lambda=2.0042115918485846e-08 > > > > 25 SNES Function norm 1.291635197798e+02 > > > > 0 KSP Residual norm 1.874745766083e+04 > > > > 1 KSP Residual norm 1.476978150334e-09 > > > > Line search: gnorm after quadratic fit 4.089262111368e+11 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.101717203770e+10 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.352565940292e+09 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 7.879613196620e+08 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 9.698613558125e+07 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.175566265039e+07 lambda=3.1250000000000002e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.382919964952e+06 lambda=1.5625000000000001e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.545431975334e+05 lambda=7.8125000000000004e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.713561369103e+04 lambda=3.9062500000000002e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.031789308419e+03 lambda=1.9531250000000001e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 9.205847020738e+02 lambda=9.7656250000000005e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.957203153158e+02 lambda=2.8132879163728503e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.297923302791e+02 lambda=2.8132879163728504e-06 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.291698100579e+02 lambda=2.8132879163728504e-07 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.291635794525e+02 lambda=2.8132879163728506e-08 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.291635200489e+02 lambda=2.8132879163728508e-09 > > > > Line search: Cubically determined step, current gnorm > 1.291635197275e+02 lambda=8.0832061492461345e-10 > > > > 26 SNES Function norm 1.291635197275e+02 > > > > 0 KSP Residual norm 9.248381077528e+04 > > > > 1 KSP Residual norm 7.262307068447e-09 > > > > Line search: gnorm after quadratic fit 4.920647210624e+13 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.153216818065e+12 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 7.697543960375e+11 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 9.637004379805e+10 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.208402653149e+10 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.519988135798e+09 lambda=3.1250000000000002e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.923903214787e+08 lambda=1.5625000000000001e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.465663001976e+07 lambda=7.8125000000000004e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.238603967195e+06 lambda=3.9062500000000002e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.459179143177e+05 lambda=1.9531250000000001e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.676301042792e+04 lambda=9.7656250000000005e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.135808875752e+04 lambda=4.8828125000000003e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.275714918657e+03 lambda=2.4414062500000001e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.719037747616e+02 lambda=1.2207031250000001e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.039826156716e+02 lambda=5.5609199181402721e-06 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.308092967809e+02 lambda=9.1057337296683134e-07 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.291796742824e+02 lambda=9.1057337296683134e-08 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.291636800174e+02 lambda=9.1057337296683134e-09 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.291635212255e+02 lambda=9.1057337296683134e-10 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.291635197320e+02 lambda=9.1057337296683139e-11 > > > > Line search: Cubically determined step, current gnorm > 1.291635197254e+02 lambda=3.2898162617097329e-11 > > > > 27 SNES Function norm 1.291635197254e+02 > > > > 0 KSP Residual norm 4.818745996826e+05 > > > > 1 KSP Residual norm 3.300979345194e-08 > > > > Line search: gnorm after quadratic fit 6.957046028867e+15 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 8.695654311477e+14 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.086793500688e+14 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.358083744813e+13 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.696584801696e+12 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.118183549773e+11 lambda=3.1250000000000002e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.641372080976e+10 lambda=1.5625000000000001e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.285878535769e+09 lambda=7.8125000000000004e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.068045470276e+08 lambda=3.9062500000000002e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.988290932539e+07 lambda=1.9531250000000001e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.001404304764e+06 lambda=9.7656250000000005e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.962234585736e+05 lambda=4.8828125000000003e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 7.648190078115e+04 lambda=2.4414062500000001e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 9.098288624714e+03 lambda=1.2207031250000001e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.025132922751e+03 lambda=6.1035156250000003e-06 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.536770142392e+02 lambda=3.0517578125000002e-06 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.529553964021e+02 lambda=6.6615844706846272e-07 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.293970371303e+02 lambda=6.6615844706846277e-08 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.291658631829e+02 lambda=6.6615844706846284e-09 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.291635430890e+02 lambda=6.6615844706846284e-10 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.291635199508e+02 lambda=6.6615844706846284e-11 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.291635197268e+02 lambda=6.6615844706846284e-12 > > > > Line search: Cubically determined step, current gnorm > 1.291635197253e+02 lambda=1.2496728806533799e-12 > > > > 28 SNES Function norm 1.291635197253e+02 > > > > 0 KSP Residual norm 2.124622394867e+06 > > > > 1 KSP Residual norm 2.766225333896e-07 > > > > Line search: gnorm after quadratic fit 5.963587884154e+17 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 7.454611858824e+16 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 9.318582340500e+15 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.164902175749e+15 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.456326197371e+14 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.820904039469e+13 lambda=3.1250000000000002e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.277371273495e+12 lambda=1.5625000000000001e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.849819609184e+11 lambda=7.8125000000000004e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.570050545145e+10 lambda=3.9062500000000002e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.482064028328e+09 lambda=1.9531250000000001e-04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.651631635063e+08 lambda=9.7656250000000005e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 7.188623828904e+07 lambda=4.8828125000000003e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 9.302868645305e+06 lambda=2.4414062500000001e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.245214424313e+06 lambda=1.2207031250000001e-05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.775004618570e+05 lambda=6.1035156250000003e-06 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.810228834086e+04 lambda=3.0517578125000002e-06 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.148910945566e+03 lambda=1.5258789062500001e-06 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.133679879416e+03 lambda=7.6293945312500004e-07 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.382468615011e+02 lambda=3.8146972656250002e-07 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.519773483633e+02 lambda=1.4103864371136453e-07 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.293690599792e+02 lambda=1.4103864371136454e-08 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.291655645282e+02 lambda=1.4103864371136455e-09 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.291635401518e+02 lambda=1.4103864371136456e-10 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.291635199283e+02 lambda=1.4103864371136456e-11 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.291635197272e+02 lambda=1.4103864371136456e-12 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.291635197253e+02 lambda=1.4103864371136457e-13 > > > > Line search: unable to find good step length! After 25 tries > > > > Line search: fnorm=1.2916351972528861e+02, > gnorm=1.2916351972529532e+02, ynorm=2.1246218291095798e+06, > minlambda=9.9999999999999998e-13, lambda=1.4103864371136457e-13, initial > slope=-1.6683210999382733e+04 > > > > 0 SNES Function norm 7.158176401507e+03 > > > > 0 KSP Residual norm 7.545626598553e+02 > > > > 1 KSP Residual norm 2.192822940623e-11 > > > > Line search: gnorm after quadratic fit 6.003975664723e+07 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 7.501930637484e+06 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 9.380142516806e+05 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.179837352860e+05 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.656902039419e+04 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 7.340091686120e+03 lambda=3.1250000000000002e-03 > > > > Line search: Cubically determined step, current gnorm > 7.127478647243e+03 lambda=1.5625000000000001e-03 > > > > 1 SNES Function norm 7.127478647243e+03 > > > > 0 KSP Residual norm 3.139792512249e+01 > > > > 1 KSP Residual norm 5.765552480238e-13 > > > > Line search: gnorm after quadratic fit 7.131728282938e+03 > > > > Line search: Cubically determined step, current gnorm > 6.730387269330e+03 lambda=5.0000000000000003e-02 > > > > 2 SNES Function norm 6.730387269330e+03 > > > > 0 KSP Residual norm 2.247436817553e+01 > > > > 1 KSP Residual norm 4.129717651221e-13 > > > > Line search: gnorm after quadratic fit 6.018304311910e+03 > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > 3 SNES Function norm 6.018304311910e+03 > > > > 0 KSP Residual norm 1.605973421081e+01 > > > > 1 KSP Residual norm 3.614891198134e-13 > > > > Line search: gnorm after quadratic fit 5.394599276028e+03 > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > 4 SNES Function norm 5.394599276028e+03 > > > > 0 KSP Residual norm 1.491002227850e+01 > > > > 1 KSP Residual norm 5.905756964447e-13 > > > > Line search: gnorm after quadratic fit 4.845108544722e+03 > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > 5 SNES Function norm 4.845108544722e+03 > > > > 0 KSP Residual norm 1.562997766581e+02 > > > > 1 KSP Residual norm 5.722461855805e-12 > > > > Line search: gnorm after quadratic fit 1.663505509947e+05 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.368547472010e+04 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.067825049920e+03 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.852173464442e+03 lambda=1.2500000000000001e-02 > > > > Line search: Cubically determined step, current gnorm > 4.819549937425e+03 lambda=6.2500000000000003e-03 > > > > 6 SNES Function norm 4.819549937425e+03 > > > > 0 KSP Residual norm 1.652787385042e+01 > > > > 1 KSP Residual norm 7.774483442550e-13 > > > > Line search: gnorm after quadratic fit 2.868840270198e+03 > > > > Line search: Quadratically determined step, > lambda=3.9586658383856743e-01 > > > > 7 SNES Function norm 2.868840270198e+03 > > > > 0 KSP Residual norm 1.220061851091e+01 > > > > 1 KSP Residual norm 4.785407437718e-13 > > > > Line search: gnorm after quadratic fit 2.616720732407e+03 > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > 8 SNES Function norm 2.616720732407e+03 > > > > 0 KSP Residual norm 2.884722153958e+01 > > > > 1 KSP Residual norm 5.474553921306e-13 > > > > Line search: gnorm after quadratic fit 3.025386805317e+03 > > > > Line search: Cubically determined step, current gnorm > 2.572110173067e+03 lambda=5.0000000000000003e-02 > > > > 9 SNES Function norm 2.572110173067e+03 > > > > 0 KSP Residual norm 5.239447686736e+01 > > > > 1 KSP Residual norm 1.006906008399e-12 > > > > Line search: gnorm after quadratic fit 5.237562098046e+03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.722529781980e+03 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm > 2.553072891461e+03 lambda=2.5000000000000001e-02 > > > > 10 SNES Function norm 2.553072891461e+03 > > > > 0 KSP Residual norm 6.511316788880e+00 > > > > 1 KSP Residual norm 1.340296659008e-13 > > > > Line search: gnorm after quadratic fit 2.299704119080e+03 > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > 11 SNES Function norm 2.299704119080e+03 > > > > 0 KSP Residual norm 5.268131426587e+00 > > > > 1 KSP Residual norm 1.017563310127e-13 > > > > Line search: Using full step: fnorm 2.299704119080e+03 gnorm > 7.642690039388e+02 > > > > 12 SNES Function norm 7.642690039388e+02 > > > > 0 KSP Residual norm 1.467735721574e+01 > > > > 1 KSP Residual norm 1.090242963543e-12 > > > > Line search: gnorm after quadratic fit 1.042766084830e+03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 7.924803860137e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm > 7.581126971182e+02 lambda=1.8508848315139208e-02 > > > > 13 SNES Function norm 7.581126971182e+02 > > > > 0 KSP Residual norm 2.222609581896e+00 > > > > 1 KSP Residual norm 5.661437314341e-14 > > > > Line search: gnorm after quadratic fit 6.235337602260e+02 > > > > Line search: Quadratically determined step, > lambda=2.1172883827013136e-01 > > > > 14 SNES Function norm 6.235337602260e+02 > > > > 0 KSP Residual norm 3.080209609798e+00 > > > > 1 KSP Residual norm 6.073476899313e-14 > > > > Line search: gnorm after quadratic fit 5.704745248520e+02 > > > > Line search: Quadratically determined step, > lambda=1.0142301129466913e-01 > > > > 15 SNES Function norm 5.704745248520e+02 > > > > 0 KSP Residual norm 5.628316803979e+00 > > > > 1 KSP Residual norm 9.930477041779e-14 > > > > Line search: gnorm after quadratic fit 5.401354794776e+02 > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > 16 SNES Function norm 5.401354794776e+02 > > > > 0 KSP Residual norm 2.052541406719e+01 > > > > 1 KSP Residual norm 4.328836834239e-13 > > > > Line search: gnorm after quadratic fit 1.709850100987e+03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 7.717966555703e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.414032576976e+02 lambda=8.7805694170804971e-03 > > > > Line search: Cubically determined step, current gnorm > 5.391967144330e+02 lambda=3.6341472475199424e-03 > > > > 17 SNES Function norm 5.391967144330e+02 > > > > 0 KSP Residual norm 2.246993769488e+00 > > > > 1 KSP Residual norm 5.078373642913e-14 > > > > Line search: gnorm after quadratic fit 4.939618639951e+02 > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > 18 SNES Function norm 4.939618639951e+02 > > > > 0 KSP Residual norm 2.155867648564e+00 > > > > 1 KSP Residual norm 4.438622106380e-14 > > > > Line search: gnorm after quadratic fit 4.334377322188e+02 > > > > Line search: Quadratically determined step, > lambda=1.5092486954829210e-01 > > > > 19 SNES Function norm 4.334377322188e+02 > > > > 0 KSP Residual norm 8.318284791610e+00 > > > > 1 KSP Residual norm 6.910116607023e-13 > > > > Line search: gnorm after quadratic fit 6.148799641401e+02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.502386288041e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm > 4.297879862602e+02 lambda=1.9565738732695813e-02 > > > > 20 SNES Function norm 4.297879862602e+02 > > > > 0 KSP Residual norm 7.593855254976e+01 > > > > 1 KSP Residual norm 1.300639045149e-12 > > > > Line search: gnorm after quadratic fit 7.318016560287e+04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 7.832525429452e+03 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.543595712952e+03 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.752901058720e+02 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.309726315570e+02 lambda=1.2500000000000002e-03 > > > > Line search: Cubically determined step, current gnorm > 4.297464967378e+02 lambda=2.0986409143217158e-04 > > > > 21 SNES Function norm 4.297464967378e+02 > > > > 0 KSP Residual norm 8.492609701850e+00 > > > > 1 KSP Residual norm 2.830329105288e-13 > > > > Line search: gnorm after quadratic fit 6.575200413213e+02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.532760802544e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm > 4.268212296998e+02 lambda=1.8460064973695799e-02 > > > > 22 SNES Function norm 4.268212296998e+02 > > > > 0 KSP Residual norm 2.527155905469e+00 > > > > 1 KSP Residual norm 2.235724978394e-13 > > > > Line search: gnorm after quadratic fit 3.958132075117e+02 > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > 23 SNES Function norm 3.958132075117e+02 > > > > 0 KSP Residual norm 3.425644398425e+00 > > > > 1 KSP Residual norm 7.166017790799e-14 > > > > Line search: gnorm after quadratic fit 3.803199338641e+02 > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > 24 SNES Function norm 3.803199338641e+02 > > > > 0 KSP Residual norm 3.581435186688e+00 > > > > 1 KSP Residual norm 1.730091027109e-13 > > > > Line search: gnorm after quadratic fit 3.678433353709e+02 > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > 25 SNES Function norm 3.678433353709e+02 > > > > 0 KSP Residual norm 2.817439291614e+00 > > > > 1 KSP Residual norm 8.592333136485e-13 > > > > Line search: gnorm after quadratic fit 3.472671313564e+02 > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > 26 SNES Function norm 3.472671313564e+02 > > > > 0 KSP Residual norm 1.830066839089e+00 > > > > 1 KSP Residual norm 3.248934231575e-14 > > > > Line search: gnorm after quadratic fit 3.195079998571e+02 > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > 27 SNES Function norm 3.195079998571e+02 > > > > 0 KSP Residual norm 3.775823654589e+00 > > > > 1 KSP Residual norm 1.316233059492e-13 > > > > Line search: gnorm after quadratic fit 3.252874639934e+02 > > > > Line search: Cubically determined step, current gnorm > 3.125168318399e+02 lambda=5.0000000000000003e-02 > > > > 28 SNES Function norm 3.125168318399e+02 > > > > 0 KSP Residual norm 3.892613775622e+00 > > > > 1 KSP Residual norm 7.093200713216e-11 > > > > Line search: gnorm after quadratic fit 3.137590389484e+02 > > > > Line search: Cubically determined step, current gnorm > 3.045559021319e+02 lambda=5.0000000000000003e-02 > > > > 29 SNES Function norm 3.045559021319e+02 > > > > 0 KSP Residual norm 2.364531179390e+00 > > > > 1 KSP Residual norm 1.615423543115e-12 > > > > Line search: gnorm after quadratic fit 2.864449141431e+02 > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > 30 SNES Function norm 2.864449141431e+02 > > > > 0 KSP Residual norm 5.187063704081e+00 > > > > 1 KSP Residual norm 4.254799504045e-13 > > > > Line search: gnorm after quadratic fit 3.171238299438e+02 > > > > Line search: Cubically determined step, current gnorm > 2.859321807369e+02 lambda=4.9550691080557742e-02 > > > > 31 SNES Function norm 2.859321807369e+02 > > > > 0 KSP Residual norm 2.400449127985e+01 > > > > 1 KSP Residual norm 5.221032480453e-13 > > > > Line search: gnorm after quadratic fit 1.812538817802e+03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.647888939229e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.905120335847e+02 lambda=7.3371687404129469e-03 > > > > Line search: Cubically determined step, current gnorm > 2.857698450683e+02 lambda=1.3231746793531958e-03 > > > > 32 SNES Function norm 2.857698450683e+02 > > > > 0 KSP Residual norm 7.438521293559e+00 > > > > 1 KSP Residual norm 1.293652874831e-12 > > > > Line search: gnorm after quadratic fit 3.600694148787e+02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.932936811991e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm > 2.832774969882e+02 lambda=1.8636088141277370e-02 > > > > 33 SNES Function norm 2.832774969882e+02 > > > > 0 KSP Residual norm 2.676138557891e+00 > > > > 1 KSP Residual norm 5.204105674042e-12 > > > > Line search: gnorm after quadratic fit 2.698470565576e+02 > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > 34 SNES Function norm 2.698470565576e+02 > > > > 0 KSP Residual norm 1.009562156863e+01 > > > > 1 KSP Residual norm 3.544140587695e-13 > > > > Line search: gnorm after quadratic fit 5.672695948559e+02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.197216154647e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm > 2.694068135292e+02 lambda=1.0762403784106927e-02 > > > > 35 SNES Function norm 2.694068135292e+02 > > > > 0 KSP Residual norm 3.927549314525e+00 > > > > 1 KSP Residual norm 2.619134786598e-13 > > > > Line search: gnorm after quadratic fit 2.646675787349e+02 > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > 36 SNES Function norm 2.646675787349e+02 > > > > 0 KSP Residual norm 3.630219417922e+01 > > > > 1 KSP Residual norm 1.546302717349e-12 > > > > Line search: gnorm after quadratic fit 1.827432666108e+04 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.342968941151e+03 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 8.008633273369e+02 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.490753494196e+02 lambda=1.2345129233072847e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.682474011960e+02 lambda=3.3291959087019770e-03 > > > > Line search: Cubically determined step, current gnorm > 2.646227701989e+02 lambda=4.0529212866107715e-04 > > > > 37 SNES Function norm 2.646227701989e+02 > > > > 0 KSP Residual norm 8.122774697994e+00 > > > > 1 KSP Residual norm 1.316362046092e-13 > > > > Line search: gnorm after quadratic fit 4.731092571363e+02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.030088374328e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm > 2.637462652877e+02 lambda=9.1057248517509397e-03 > > > > 38 SNES Function norm 2.637462652877e+02 > > > > 0 KSP Residual norm 2.601520363063e+00 > > > > 1 KSP Residual norm 1.060764270007e-12 > > > > Line search: gnorm after quadratic fit 2.536856446094e+02 > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > 39 SNES Function norm 2.536856446094e+02 > > > > 0 KSP Residual norm 5.447955134327e+01 > > > > 1 KSP Residual norm 2.556989975730e-12 > > > > Line search: gnorm after quadratic fit 9.199250935618e+03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.998238940105e+03 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.227083769291e+02 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.852215674478e+02 lambda=8.5024965111563117e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.537821339347e+02 lambda=8.5024965111563122e-04 > > > > Line search: Cubically determined step, current gnorm > 2.536484146652e+02 lambda=2.9594242443314720e-04 > > > > 40 SNES Function norm 2.536484146652e+02 > > > > 0 KSP Residual norm 3.357359266965e+01 > > > > 1 KSP Residual norm 8.485166742752e-11 > > > > Line search: gnorm after quadratic fit 3.327150899857e+03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 8.660943990394e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.428891921377e+02 lambda=2.2262238648584176e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.550059920785e+02 lambda=3.9120439672600755e-03 > > > > Line search: Cubically determined step, current gnorm > 2.535425543202e+02 lambda=8.8078244093807846e-04 > > > > 41 SNES Function norm 2.535425543202e+02 > > > > 0 KSP Residual norm 1.982789391732e+01 > > > > 1 KSP Residual norm 1.156473750758e-11 > > > > Line search: gnorm after quadratic fit 9.648483369708e+02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.023504841042e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.554919970151e+02 lambda=8.7092873850291869e-03 > > > > Line search: Cubically determined step, current gnorm > 2.532490636747e+02 lambda=2.4564558988847251e-03 > > > > 42 SNES Function norm 2.532490636747e+02 > > > > 0 KSP Residual norm 1.762994613361e+01 > > > > 1 KSP Residual norm 4.550684860593e-12 > > > > Line search: gnorm after quadratic fit 6.772107527838e+02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.370541870778e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.532869639177e+02 lambda=7.7662700854918328e-03 > > > > Line search: Cubically determined step, current gnorm > 2.527651129995e+02 lambda=3.8686733161537824e-03 > > > > 43 SNES Function norm 2.527651129995e+02 > > > > 0 KSP Residual norm 1.559278923951e+01 > > > > 1 KSP Residual norm 1.060470887103e-11 > > > > Line search: gnorm after quadratic fit 7.344361373020e+02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.498001534426e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.530518382567e+02 lambda=7.6730113050967469e-03 > > > > Line search: Cubically determined step, current gnorm > 2.523423548732e+02 lambda=3.4156098513217236e-03 > > > > 44 SNES Function norm 2.523423548732e+02 > > > > 0 KSP Residual norm 1.190500639095e+01 > > > > 1 KSP Residual norm 6.311739265577e-12 > > > > Line search: gnorm after quadratic fit 4.875196633557e+02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.933215922947e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm > 2.516782376717e+02 lambda=9.8878729665301743e-03 > > > > 45 SNES Function norm 2.516782376717e+02 > > > > 0 KSP Residual norm 1.003632001309e+01 > > > > 1 KSP Residual norm 7.039473047666e-13 > > > > Line search: gnorm after quadratic fit 3.417133560813e+02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.636443273929e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm > 2.499729768042e+02 lambda=1.5332495922160540e-02 > > > > 46 SNES Function norm 2.499729768042e+02 > > > > 0 KSP Residual norm 5.252587112411e+01 > > > > 1 KSP Residual norm 2.072629114336e-12 > > > > Line search: gnorm after quadratic fit 7.891803681498e+03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.819076698717e+03 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.911876424956e+02 lambda=2.4538865368827514e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.688195882303e+02 lambda=6.5764457912135515e-03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.500076295129e+02 lambda=6.5764457912135523e-04 > > > > Line search: Cubically determined step, current gnorm > 2.499390700783e+02 lambda=2.7231956365922875e-04 > > > > 47 SNES Function norm 2.499390700783e+02 > > > > 0 KSP Residual norm 4.007648116930e+01 > > > > 1 KSP Residual norm 5.646654234336e-11 > > > > Line search: gnorm after quadratic fit 6.276152857499e+03 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.418274035925e+03 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.785345842563e+02 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.665412152699e+02 lambda=8.0607289886479045e-03 > > > > Line search: Cubically determined step, current gnorm > 2.499109739904e+02 lambda=8.0607289886479045e-04 > > > > 48 SNES Function norm 2.499109739904e+02 > > > > 0 KSP Residual norm 1.339756751889e+01 > > > > 1 KSP Residual norm 2.559175980945e-13 > > > > Line search: gnorm after quadratic fit 6.052259901869e+02 > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.217431518450e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm > 2.496541765916e+02 lambda=7.0239599632283649e-03 > > > > 49 SNES Function norm 2.496541765916e+02 > > > > 0 KSP Residual norm 5.340771873687e+00 > > > > 1 KSP Residual norm 1.207454778077e-13 > > > > Line search: gnorm after quadratic fit 2.760767095070e+02 > > > > Line search: Cubically determined step, current gnorm > 2.491630276458e+02 lambda=5.0000000000000003e-02 > > > > 50 SNES Function norm 2.491630276458e+02 > > > > > > > > > > > > On Sat, Aug 26, 2017 at 11:45 PM, Barry Smith > wrote: > > > > > > > > > On Aug 26, 2017, at 10:43 PM, zakaryah . > wrote: > > > > > > > > > > Hi Barry - many thanks for taking the time to understand my many > problems and providing so much help. > > > > > > > > > > The reason I was concerned that I could not alter the linesearch > was when I tried to use bt instead of the L-BFGS default, cp, the code > crashed with an error like "Could not get Jacobian". Maybe this is an > incompatibility like you say, since L-BFGS only uses the initial Jacobian > and I never tried setting the scale type. > > > > > > > > > > I took your advice and tried to shrink the problem. First I tried > shrinking by a factor 1000 but this converged very quickly with all test > data I could provide, including the data which was problematic with the > large grid. So I settled for a reduction in size by a factor 125. The > grid size is 13,230. This is a decent test case because the solver fails > to converge with the options I was using before, and it is small enough > that I can run it with the options you suggested (-snes_fd_color -snes_type > newtonls -snes_monitor -snes_linesearch_monitor -ksp_monitor -pc_type lu). > > > > > > > > > > The output is 1800 lines long - how shall I share it? > > > > > > > > Just email it, that is small enough for email. > > > > > > > > Barry > > > > > > > > > > > > > > > > > > > > > > > > > > > > > On Sat, Aug 26, 2017 at 7:38 PM, Barry Smith > wrote: > > > > > > > > > > > On Aug 26, 2017, at 5:56 PM, zakaryah . > wrote: > > > > > > > > > > > > I'm using PETSc's SNES methods to solve PDEs which result from > Euler-Lagrange equations for the strain energy of a 3D displacement field. > There is an additional term in the Lagrangian which describes external > forces which arise from various data sets, and that term contains > nonlinearities (field terms higher than linear). The grid has about 1.6e6 > elements, and the displacement field has 3 components at each grid element. > > > > > > > > > > > > I'm trying to solve a sequence of successively more complicated > equations, and the latest equation is failing to converge on some data > sets. In particular, the methods were successful for the infinitesimal bulk > strain (compression) energy, as well as the full infinitesimal strain > energy (bulk + shear), but I'm now trying to generalize to the finite > strain, as certain data sets are known to result from displacement fields > for which the infinitesimal strain is a poor approximation. > > > > > > > > > > > > I'm using a DMDA, closely following example 48, and my preferred > solver is L-BFGS. > > > > > > > > > > So you are using ? > > > > > > > > > > -snes_type qn -snes_qn_type lbfgs > > > > > > > > > > > > > > > > > I have read the FAQs "Why is Newton's method not converging??" > and "Why is my iterative linear solver not converging??"? which have raised > a number of questions: > > > > > > > > > > Quasi Newton methods either don't use Jacobians or use only the > initial Jacobian (the idea behind quasi-Newton methods is to approximate > Jacobian information from previous iterations without having the user > compute a Jacobian at each iteration). With PETSc's qn it only uses the > Jacobian if you use the option > > > > > > > > > > -snes_qn_scale_type Jacobian > > > > > > > > > > otherwise the Jacobian is never computed or used > > > > > > > > > > > > > > > > > > > > > > Is there documentation for the DMDA/SNES methods somewhere? I > don't understand these very well. For example, I am not allocating any > matrix for the global Jacobian, and I believe this prevents me from > changing the line search. If I'm mistaken I would love to see an example > of changing the line search type while using DMDA/SNES. > > > > > > > > > > Whether you provide a Jacobian or not is orthogonal to the line > search. > > > > > > > > > > You should be able to change the line search with > > > > > > > > > > -snes_linesearch_type bt or nleqerr or basic or l2 or cp > > > > > > > > > > not all of them may work with qn > > > > > > > > > > > > > > > > > > > > > > I don't know how to interpret the linesearch monitor. Even for > problems which are converging properly, the linesearch monitor reports > "lssucceed=0" on every iteration. Is this a problem? > > > > > > > > > > It returns a 0 if the line search does not believe it has > achieved "sufficient decrease" in the function norm (or possibly some other > measure of decrease) you should run -snes_linesearch_monitor also with the > option -snes_monitor to see what is happening to the function norm > > > > > > > > > > For qn you can add the option > > > > > > > > > > -snes_qn_monitor > > > > > > > > > > to get more detailed monitoring > > > > > > > > > > > > > > > > > > > > > > I'm also having trouble understanding the methods for > troubleshooting. I suspect that I've made an error in the analytical > Jacobian, which has a rather large number of non-zero elements, but I have > no idea how to use -snes_type test -snes_test_display. The FAQs mention > that some troubleshooting tools are more useful for small test problems. > How small is small? > > > > > > > > > > Tiny, at most a few dozen rows and columns in the Jacobin. > > > > > > > > > > You should run without the -snes_test_display information, what > does it say? Does it indicate the Jacobian or report there is likely a > problem? > > > > > > > > > > With DMDA you can also use -snes_fd_color to have PETSc > compute the Jacobian for you instead of using your analytical form. If it > works with this, but not your Jacobian then your Jacobian is wrong. > > > > > > > > > > > When I try to run the program with -snes_type test > -snes_test_display, I get errors like: > > > > > > > > > > > > [0]PETSC ERROR: Argument out of range [0]PETSC ERROR: Local > index 1076396032 too large 4979879 (max) at 0 > > > > > > > > > > > > The second size is 1 less than the number of field elements, > while the first number seems too large for any aspect of the problem - the > Jacobian has at most 59 non-zero columns per row. > > > > > > > > > > > > Because I suspect a possible error in the Jacobian, I ran with > -snes_mf_operator -pc_type ksp -ksp_ksp_rtol 1e-12 and observed very > similar failure to converge (diverging residual) as with the explicit > Jacobian. > > > > > > > > > > What do you get with -ksp_monitor -ksp_ksp_monitor it sounds > like the true Jacobian is either very ill-conditioned or your function > evaluation is wrong. > > > > > > > > > > > Do I need to set an SNES method which is somehow compatible with > the "matrix-free" approach? If I instead use -snes_mf, the problem seems to > converge, but horrendously slowly (true residual relative decrease by about > 1e-5 per iteration). I suppose this supports my suspicion that the > Jacobian is incorrect but doesn't really suggest a solution. > > > > > > > > > > > > Is it possible that the analytical Jacobian is correct, but > somehow pathological, which causes the SNES to diverge? > > > > > > > > > > Yes > > > > > > > > > > > Neither the Jacobian nor the function have singularities. > > > > > > > > > > > > Thanks for any help you can provide! > > > > > > > > > > Try really hard to set up a small problem (like just use a > very coarse grid) to experiment with as you try to get convergence. Using a > big problem for debugging convergence is a recipe for pain. > > > > > > > > > > Also since you have a Jacobian I would start with > -snes_fd_color -snes_type ls -snes_monitor -snes_linesearch_monitor > -ksp_monitor -pc_type lu (not on a huge problem), what happens? Send the > output > > > > > > > > > > Barry > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Sun Aug 27 18:29:31 2017 From: bsmith at mcs.anl.gov (Barry Smith) Date: Sun, 27 Aug 2017 18:29:31 -0500 Subject: [petsc-users] A number of questions about DMDA with SNES and Quasi-Newton methods In-Reply-To: References: <020DAED9-AAAD-4741-976B-BB2EF6C79D3F@mcs.anl.gov> <5BF530F6-8D79-47E6-B2C5-B0702FF2AA59@mcs.anl.gov> <7EE84495-4346-4BFB-B9AD-BCAA3C722461@mcs.anl.gov> <08AA1273-062D-4FDD-8709-40AA1FE8AA92@mcs.anl.gov> Message-ID: <06932E72-E8F3-4EA8-889F-A570AD660E32@mcs.anl.gov> > On Aug 27, 2017, at 6:19 PM, zakaryah . wrote: > > Heh, I guess it's at least a sign that the two fd methods agreed. This takes me back to my earlier question - when I call MatSetOption(jac,MAT_NEW_NONZERO_LOCATION_ERR,PETSC_FALSE), what is jac? Do I need to preallocate it? Do I need to get it from the SNES? Do I need to set that matrix as the SNES Jacobian? Do I allocate the actual number of non-zero rows, or the entirety of the stencil? I notice that -snes_test_display reports values for the entire stencil, even though of the 27 points in the stencil, only 19 can be non-zero. Back up a minute I didn't read your previous email well enough, sorry. See below > > On Sun, Aug 27, 2017 at 5:51 PM, Barry Smith wrote: > > Sorry this a flaw with the current release. Call > > MatSetOption(jac,MAT_NEW_NONZERO_LOCATION_ERR,PETSC_FALSE) > > before the call to the solver. > > > > On Aug 27, 2017, at 12:54 PM, zakaryah . wrote: > > > > Is it suspicious that the KSP converges so quickly? I have no experience with how the solvers behave on such small grids. > > > > Also, I ran the code with -snes_type test on a very small grid (1530 elements). The simpler version of the PDE ran fine, and showed good agreement of the matrices. However, the more complicated version crashes with the following errors: > > > > Testing hand-coded Jacobian, if the ratio is > > > > O(1.e-8), the hand-coded Jacobian is probably correct. > > > > Run with -snes_test_display to show difference > > > > of hand-coded and finite difference Jacobian. > > > > [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- > > > > [0]PETSC ERROR: Argument out of range > > > > [0]PETSC ERROR: Inserting a new nonzero at (7,0) in the matrix > > > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. > > > > [0]PETSC ERROR: Petsc Release Version 3.7.3, Jul, 24, 2016 > > > > [0]PETSC ERROR: #1 MatSetValues_SeqAIJ() line 484 in /PETSc/build/petsc-3.7.3/src/mat/impls/aij/seq/aij.c > > > > [0]PETSC ERROR: #2 MatSetValues() line 1190 in /PETSc/build/petsc-3.7.3/src/mat/interface/matrix.c > > > > [0]PETSC ERROR: #3 MatSetValuesLocal() line 2053 in /PETSc/build/petsc-3.7.3/src/mat/interface/matrix.c > > > > [0]PETSC ERROR: #4 MatSetValuesStencil() line 1447 in /PETSc/build/petsc-3.7.3/src/mat/interface/matrix.c > > > > Does this indicate a bug in the Jacobian calculation? I don't think I set values outside of the stencil... Yes something is definitely wrong, you are inserting a value in a location the matrix was not expecting. What are your arguments to DMDACreate()? For stencil width and stencil type? You can run in the debugger to see why the stencil value doesn't "fit". Barry > > > > > > On Sun, Aug 27, 2017 at 12:14 AM, zakaryah . wrote: > > Sure - it was this: > > > > mpiexec -n 1 -snes_fd_color -snes_type newtonls -snes_monitor -snes_linesearch_monitor -ksp_monitor -pc_type lu > > > > On Sun, Aug 27, 2017 at 12:11 AM, Barry Smith wrote: > > > > > On Aug 26, 2017, at 10:55 PM, zakaryah . wrote: > > > > > > Yes, except I changed "-snes_type ls" to "-snes_type newtonls" because PETSc complained that ls wasn't a known method. > > > > Sorry, my memory is not as good as it used to be; but what other options did you use? Send the exact command line. > > > > > > Barry > > ' > > > > > > On Sat, Aug 26, 2017 at 11:52 PM, Barry Smith wrote: > > > > > > My exact options did you run with? > > > > > > > On Aug 26, 2017, at 10:48 PM, zakaryah . wrote: > > > > > > > > Here's the output, from the data set which does not converge with l-bfgs: > > > > > > > > 0 SNES Function norm 1.370293318432e+04 > > > > 0 KSP Residual norm 7.457506389218e+02 > > > > 1 KSP Residual norm 2.244764079994e-10 > > > > Line search: gnorm after quadratic fit 6.541298279196e+05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.963717927372e+04 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.788909416707e+04 lambda=2.5000000000000001e-02 > > > > Line search: Cubically determined step, current gnorm 1.340565762719e+04 lambda=1.2500000000000001e-02 > > > > 1 SNES Function norm 1.340565762719e+04 > > > > 0 KSP Residual norm 4.096066553372e+02 > > > > 1 KSP Residual norm 3.313671167444e-11 > > > > Line search: gnorm after quadratic fit 1.113749573695e+06 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.406390140546e+05 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.126781917443e+04 lambda=2.5000000000000001e-02 > > > > Line search: Cubically determined step, current gnorm 1.272988597973e+04 lambda=1.2500000000000001e-02 > > > > 2 SNES Function norm 1.272988597973e+04 > > > > 0 KSP Residual norm 8.291344597817e+01 > > > > 1 KSP Residual norm 7.182258362182e-12 > > > > Line search: gnorm after quadratic fit 1.121913743889e+04 > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > 3 SNES Function norm 1.121913743889e+04 > > > > 0 KSP Residual norm 6.830535877014e+01 > > > > 1 KSP Residual norm 3.629826411580e-12 > > > > Line search: gnorm after quadratic fit 9.966344973786e+03 > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > 4 SNES Function norm 9.966344973786e+03 > > > > 0 KSP Residual norm 5.137691531345e+01 > > > > 1 KSP Residual norm 1.954502098181e-12 > > > > Line search: gnorm after quadratic fit 8.905508641232e+03 > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > 5 SNES Function norm 8.905508641232e+03 > > > > 0 KSP Residual norm 4.295019262963e+01 > > > > 1 KSP Residual norm 1.581527994925e-12 > > > > Line search: gnorm after quadratic fit 7.599173694189e+03 > > > > Line search: Quadratically determined step, lambda=1.4157226463489950e-01 > > > > 6 SNES Function norm 7.599173694189e+03 > > > > 0 KSP Residual norm 3.520472291520e+01 > > > > 1 KSP Residual norm 1.169994130568e-12 > > > > Line search: gnorm after quadratic fit 6.797214843928e+03 > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > 7 SNES Function norm 6.797214843928e+03 > > > > 0 KSP Residual norm 2.683523206056e+01 > > > > 1 KSP Residual norm 9.039858014119e-13 > > > > Line search: gnorm after quadratic fit 6.098038917364e+03 > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > 8 SNES Function norm 6.098038917364e+03 > > > > 0 KSP Residual norm 2.300710560681e+01 > > > > 1 KSP Residual norm 1.010402303464e-12 > > > > Line search: gnorm after quadratic fit 5.486151385552e+03 > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > 9 SNES Function norm 5.486151385552e+03 > > > > 0 KSP Residual norm 2.824628827619e+01 > > > > 1 KSP Residual norm 1.009589866569e-12 > > > > Line search: gnorm after quadratic fit 4.964991021247e+03 > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > 10 SNES Function norm 4.964991021247e+03 > > > > 0 KSP Residual norm 6.285926028595e+01 > > > > 1 KSP Residual norm 2.833546214180e-12 > > > > Line search: gnorm after quadratic fit 2.100041391472e+04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.804051080767e+03 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm 4.893296169579e+03 lambda=2.5000000000000001e-02 > > > > 11 SNES Function norm 4.893296169579e+03 > > > > 0 KSP Residual norm 1.688978282804e+01 > > > > 1 KSP Residual norm 5.927677470786e-13 > > > > Line search: gnorm after quadratic fit 4.400894622431e+03 > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > 12 SNES Function norm 4.400894622431e+03 > > > > 0 KSP Residual norm 1.481197699600e+01 > > > > 1 KSP Residual norm 4.522572128105e-13 > > > > Line search: Using full step: fnorm 4.400894622431e+03 gnorm 2.094971849007e+03 > > > > 13 SNES Function norm 2.094971849007e+03 > > > > 0 KSP Residual norm 3.514164563318e+00 > > > > 1 KSP Residual norm 3.022385947499e-13 > > > > Line search: gnorm after quadratic fit 1.687641025382e+03 > > > > Line search: Quadratically determined step, lambda=2.0307116693368590e-01 > > > > 14 SNES Function norm 1.687641025382e+03 > > > > 0 KSP Residual norm 2.138591884686e+00 > > > > 1 KSP Residual norm 4.023500814078e-14 > > > > Line search: Using full step: fnorm 1.687641025382e+03 gnorm 1.131934218470e+03 > > > > 15 SNES Function norm 1.131934218470e+03 > > > > 0 KSP Residual norm 3.245035110327e+00 > > > > 1 KSP Residual norm 1.293626215269e-13 > > > > Line search: Using full step: fnorm 1.131934218470e+03 gnorm 7.340573607307e+02 > > > > 16 SNES Function norm 7.340573607307e+02 > > > > 0 KSP Residual norm 1.957698957904e+00 > > > > 1 KSP Residual norm 3.444648967078e-13 > > > > Line search: Using full step: fnorm 7.340573607307e+02 gnorm 5.024723505168e+02 > > > > 17 SNES Function norm 5.024723505168e+02 > > > > 0 KSP Residual norm 2.510538703839e+00 > > > > 1 KSP Residual norm 8.570440675253e-14 > > > > Line search: gnorm after quadratic fit 4.548776456608e+02 > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > 18 SNES Function norm 4.548776456608e+02 > > > > 0 KSP Residual norm 6.741705718178e-01 > > > > 1 KSP Residual norm 1.650556120809e-14 > > > > Line search: Using full step: fnorm 4.548776456608e+02 gnorm 1.351189086642e+02 > > > > 19 SNES Function norm 1.351189086642e+02 > > > > 0 KSP Residual norm 7.653741241950e+00 > > > > 1 KSP Residual norm 8.326848236950e-14 > > > > Line search: gnorm after quadratic fit 4.215455105006e+02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.889750369356e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.358691836999e+02 lambda=1.0303015930243279e-02 > > > > Line search: Cubically determined step, current gnorm 1.348911963390e+02 lambda=3.5279526770504110e-03 > > > > 20 SNES Function norm 1.348911963390e+02 > > > > 0 KSP Residual norm 4.209281176918e+00 > > > > 1 KSP Residual norm 1.233232881375e-13 > > > > Line search: gnorm after quadratic fit 1.860023264470e+02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.413911132196e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm 1.339597869053e+02 lambda=1.5787957598629023e-02 > > > > 21 SNES Function norm 1.339597869053e+02 > > > > 0 KSP Residual norm 1.718484765841e+00 > > > > 1 KSP Residual norm 6.666016296543e-14 > > > > Line search: gnorm after quadratic fit 1.326878521472e+02 > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > 22 SNES Function norm 1.326878521472e+02 > > > > 0 KSP Residual norm 1.515373499919e+00 > > > > 1 KSP Residual norm 2.259154130795e-12 > > > > Line search: gnorm after quadratic fit 1.226907316391e+02 > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > 23 SNES Function norm 1.226907316391e+02 > > > > 0 KSP Residual norm 1.080252936903e+00 > > > > 1 KSP Residual norm 1.847020526683e-14 > > > > Line search: gnorm after quadratic fit 1.163632111851e+02 > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > 24 SNES Function norm 1.163632111851e+02 > > > > 0 KSP Residual norm 2.491746958382e+00 > > > > 1 KSP Residual norm 6.389134193637e-14 > > > > Line search: gnorm after quadratic fit 1.345487153563e+02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.169738363622e+02 lambda=4.4108900954515480e-02 > > > > Line search: Cubically determined step, current gnorm 1.152177638108e+02 lambda=1.9997442889243631e-02 > > > > 25 SNES Function norm 1.152177638108e+02 > > > > 0 KSP Residual norm 5.364385501004e+00 > > > > 1 KSP Residual norm 8.457149562463e-14 > > > > Line search: gnorm after quadratic fit 2.722095758964e+02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.480946353374e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm 1.150680255994e+02 lambda=6.3560128131639167e-03 > > > > 26 SNES Function norm 1.150680255994e+02 > > > > 0 KSP Residual norm 4.302025268263e+00 > > > > 1 KSP Residual norm 1.017526937941e-13 > > > > Line search: gnorm after quadratic fit 1.956300983573e+02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.318600522939e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm 1.147123505014e+02 lambda=7.6060788653548803e-03 > > > > 27 SNES Function norm 1.147123505014e+02 > > > > 0 KSP Residual norm 6.195463111324e+00 > > > > 1 KSP Residual norm 1.235283250361e-13 > > > > Line search: gnorm after quadratic fit 3.324821547049e+02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.612593208504e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.147389525772e+02 lambda=6.1750939181374294e-03 > > > > Line search: Cubically determined step, current gnorm 1.145411432123e+02 lambda=3.0078592586792975e-03 > > > > 28 SNES Function norm 1.145411432123e+02 > > > > 0 KSP Residual norm 1.454704250187e+01 > > > > 1 KSP Residual norm 2.368485174123e-13 > > > > Line search: gnorm after quadratic fit 1.216293873116e+03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.796524621727e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.359314163651e+02 lambda=1.4867675803955788e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.146009802557e+02 lambda=1.4867675803955788e-03 > > > > Line search: Cubically determined step, current gnorm 1.145096815033e+02 lambda=5.5250912472932839e-04 > > > > 29 SNES Function norm 1.145096815033e+02 > > > > 0 KSP Residual norm 3.430451345093e+01 > > > > 1 KSP Residual norm 1.069396165938e-12 > > > > Line search: gnorm after quadratic fit 1.161329407098e+04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.260690718050e+03 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.696806489042e+02 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.960149915648e+02 lambda=1.1276129246469476e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.158113641658e+02 lambda=1.5873910451430554e-03 > > > > Line search: Cubically determined step, current gnorm 1.145062232916e+02 lambda=1.5873910451430555e-04 > > > > 30 SNES Function norm 1.145062232916e+02 > > > > 0 KSP Residual norm 2.662578971526e+01 > > > > 1 KSP Residual norm 5.464011789728e-13 > > > > Line search: gnorm after quadratic fit 4.375119254490e+03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.038018103928e+03 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.169328002874e+02 lambda=2.3789161387159519e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.262835432714e+02 lambda=5.9737415571960795e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.145626045197e+02 lambda=5.9737415571960802e-04 > > > > Line search: Cubically determined step, current gnorm 1.144968604079e+02 lambda=1.6421773527706333e-04 > > > > 31 SNES Function norm 1.144968604079e+02 > > > > 0 KSP Residual norm 6.322033697338e+01 > > > > 1 KSP Residual norm 1.507157991448e-12 > > > > Line search: gnorm after quadratic fit 5.809243699277e+04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.460487584142e+03 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.893183483197e+03 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.960337007072e+02 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.771527792790e+02 lambda=5.3912931685137378e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.150137639707e+02 lambda=5.3912931685137376e-04 > > > > Line search: Cubically determined step, current gnorm 1.144964484571e+02 lambda=5.3912931685137380e-05 > > > > 32 SNES Function norm 1.144964484571e+02 > > > > 0 KSP Residual norm 3.859510930996e+01 > > > > 1 KSP Residual norm 8.069118044382e-13 > > > > Line search: gnorm after quadratic fit 1.106329930525e+04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.155884463041e+03 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.933963819094e+02 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.849629797377e+02 lambda=9.7744286136270241e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.150857687050e+02 lambda=9.7744286136270254e-04 > > > > Line search: Cubically determined step, current gnorm 1.144922906340e+02 lambda=9.7744286136270254e-05 > > > > 33 SNES Function norm 1.144922906340e+02 > > > > 0 KSP Residual norm 4.952038022394e+01 > > > > 1 KSP Residual norm 7.460263245424e-13 > > > > Line search: gnorm after quadratic fit 3.005091127220e+04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.229308416025e+03 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.138600794682e+03 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.390856262238e+02 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.394997214983e+02 lambda=4.4582997750629580e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.146836358799e+02 lambda=4.4582997750629581e-04 > > > > Line search: Cubically determined step, current gnorm 1.144895966587e+02 lambda=4.7644082443915877e-05 > > > > 34 SNES Function norm 1.144895966587e+02 > > > > 0 KSP Residual norm 1.146914786457e+02 > > > > 1 KSP Residual norm 4.791627042400e-12 > > > > Line search: gnorm after quadratic fit 2.601294145944e+05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.324148513778e+04 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.247478406023e+03 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.200340900661e+03 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.696223112300e+02 lambda=6.1514413845115794e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.342365431983e+02 lambda=1.7502929694284564e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.146686063035e+02 lambda=1.7502929694284566e-04 > > > > Line search: Cubically determined step, current gnorm 1.144895868489e+02 lambda=1.7502929694284566e-05 > > > > 35 SNES Function norm 1.144895868489e+02 > > > > 0 KSP Residual norm 6.311017209658e+01 > > > > 1 KSP Residual norm 8.384445939117e-13 > > > > Line search: gnorm after quadratic fit 5.781533400572e+04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.419557746031e+03 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.886081770030e+03 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.945810143740e+02 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.767820854837e+02 lambda=5.3859001959289735e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.150034040559e+02 lambda=5.3859001959289732e-04 > > > > Line search: Cubically determined step, current gnorm 1.144891501665e+02 lambda=5.3859001959289732e-05 > > > > 36 SNES Function norm 1.144891501665e+02 > > > > 0 KSP Residual norm 3.880748384332e+01 > > > > 1 KSP Residual norm 6.400339290453e-13 > > > > Line search: gnorm after quadratic fit 1.122504184426e+04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.180728237366e+03 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.987870621566e+02 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.863711604331e+02 lambda=9.8150771384688824e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.150916783781e+02 lambda=9.8150771384688824e-04 > > > > Line search: Cubically determined step, current gnorm 1.144850837411e+02 lambda=9.8150771384688832e-05 > > > > 37 SNES Function norm 1.144850837411e+02 > > > > 0 KSP Residual norm 4.811537498557e+01 > > > > 1 KSP Residual norm 9.738167670242e-13 > > > > Line search: gnorm after quadratic fit 2.784098355218e+04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.885118868254e+03 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.074843354348e+03 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.255202820836e+02 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.365202996130e+02 lambda=4.3204204582016374e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.146504919412e+02 lambda=4.3204204582016374e-04 > > > > Line search: Cubically determined step, current gnorm 1.144822306241e+02 lambda=5.0376546850227848e-05 > > > > 38 SNES Function norm 1.144822306241e+02 > > > > 0 KSP Residual norm 1.120914002482e+02 > > > > 1 KSP Residual norm 5.452125292284e-12 > > > > Line search: gnorm after quadratic fit 2.427186680567e+05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.112196656857e+04 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.967397366072e+03 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.149551659770e+03 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.529630886791e+02 lambda=6.0885216927030559e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.315267519231e+02 lambda=1.6656233536183130e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.146353659250e+02 lambda=1.6656233536183130e-04 > > > > Line search: Cubically determined step, current gnorm 1.144820487391e+02 lambda=1.6656233536183130e-05 > > > > 39 SNES Function norm 1.144820487391e+02 > > > > 0 KSP Residual norm 7.182416170980e+01 > > > > 1 KSP Residual norm 1.292147133333e-12 > > > > Line search: gnorm after quadratic fit 8.255331293322e+04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.302939895170e+04 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.501228089911e+03 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.185010378583e+02 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.088179821424e+02 lambda=5.7489510178867142e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.168272901121e+02 lambda=9.7452649444612811e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144951972300e+02 lambda=9.7452649444612822e-05 > > > > Line search: Cubically determined step, current gnorm 1.144807676687e+02 lambda=2.2399506502463798e-05 > > > > 40 SNES Function norm 1.144807676687e+02 > > > > 0 KSP Residual norm 1.728679810285e+02 > > > > 1 KSP Residual norm 3.878068639716e-12 > > > > Line search: gnorm after quadratic fit 9.011020578535e+05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.111818830011e+05 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.504789858103e+04 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.754312133162e+03 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.212492111975e+02 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.199969180537e+02 lambda=2.6424184504193135e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.154794639440e+02 lambda=2.6424184504193136e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144880673342e+02 lambda=2.6424184504193136e-05 > > > > Line search: Cubically determined step, current gnorm 1.144805461570e+02 lambda=3.8712107591125690e-06 > > > > 41 SNES Function norm 1.144805461570e+02 > > > > 0 KSP Residual norm 4.162780846202e+02 > > > > 1 KSP Residual norm 1.732341544934e-11 > > > > Line search: gnorm after quadratic fit 1.355673864369e+07 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.747523002884e+06 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.342205048417e+05 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.425635699680e+04 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.882150659178e+03 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.259664786336e+03 lambda=3.1250000000000002e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.653670676209e+02 lambda=1.5625000000000001e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.453655830144e+02 lambda=5.8237455565260388e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.147659525018e+02 lambda=5.8237455565260393e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144827915995e+02 lambda=5.8237455565260400e-06 > > > > Line search: Cubically determined step, current gnorm 1.144805080017e+02 lambda=6.6689295146509104e-07 > > > > 42 SNES Function norm 1.144805080017e+02 > > > > 0 KSP Residual norm 1.004135512581e+03 > > > > 1 KSP Residual norm 3.867626041000e-09 > > > > Line search: gnorm after quadratic fit 1.832578994882e+08 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.269698278878e+07 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.792476589915e+06 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.420660371083e+05 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.321686926168e+04 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.548358078234e+03 lambda=3.1250000000000002e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.429504802276e+03 lambda=1.5625000000000001e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.317723385004e+02 lambda=7.8125000000000004e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.460079723095e+02 lambda=2.5078917343692407e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.147908977725e+02 lambda=2.5078917343692408e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144833604238e+02 lambda=2.5078917343692412e-06 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144805106824e+02 lambda=2.5078917343692411e-07 > > > > Line search: Cubically determined step, current gnorm 1.144805014337e+02 lambda=1.1468707119027746e-07 > > > > 43 SNES Function norm 1.144805014337e+02 > > > > 0 KSP Residual norm 2.418614573592e+03 > > > > 1 KSP Residual norm 6.085078742847e-10 > > > > Line search: gnorm after quadratic fit 2.598476259775e+09 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.262759415873e+08 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.116845970403e+07 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.250465130250e+06 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.863493884574e+05 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.501468163771e+04 lambda=3.1250000000000002e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.482658980483e+04 lambda=1.5625000000000001e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.802395557883e+03 lambda=7.8125000000000004e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.788149582374e+02 lambda=3.9062500000000002e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.248828337038e+02 lambda=1.8333058767960295e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.186285836222e+02 lambda=3.7550993478654105e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.145209710139e+02 lambda=3.7550993478654107e-06 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144808670668e+02 lambda=3.7550993478654111e-07 > > > > Line search: Cubically determined step, current gnorm 1.144805012252e+02 lambda=3.7550993478654114e-08 > > > > 44 SNES Function norm 1.144805012252e+02 > > > > 0 KSP Residual norm 1.432476672735e+03 > > > > 1 KSP Residual norm 7.850524783892e-11 > > > > Line search: gnorm after quadratic fit 5.336191593632e+08 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.625576866625e+07 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.181408387845e+06 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.003310644422e+06 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.236384273292e+05 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.658430638069e+04 lambda=3.1250000000000002e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.977463068161e+03 lambda=1.5625000000000001e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.674238499253e+02 lambda=7.8125000000000004e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.333616820791e+02 lambda=3.3764776729281175e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.161349153752e+02 lambda=4.0497161764116874e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144966925969e+02 lambda=4.0497161764116874e-06 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144806214839e+02 lambda=4.0497161764116878e-07 > > > > Line search: Cubically determined step, current gnorm 1.144804979966e+02 lambda=5.6339112427782378e-08 > > > > 45 SNES Function norm 1.144804979966e+02 > > > > 0 KSP Residual norm 3.453401579761e+03 > > > > 1 KSP Residual norm 4.197968028126e-09 > > > > Line search: gnorm after quadratic fit 7.554006183767e+09 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.471974940372e+08 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.191613865049e+08 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.509784334249e+07 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.943752478560e+06 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.597601716755e+05 lambda=3.1250000000000002e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.775572331075e+04 lambda=1.5625000000000001e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.418045407608e+03 lambda=7.8125000000000004e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.357066758731e+03 lambda=3.9062500000000002e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.859267839080e+02 lambda=1.9531250000000001e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.501494912160e+02 lambda=7.5160826909319168e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.148144926477e+02 lambda=7.5160826909319171e-06 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144837498478e+02 lambda=7.5160826909319179e-07 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144805227746e+02 lambda=7.5160826909319182e-08 > > > > Line search: Cubically determined step, current gnorm 1.144804974438e+02 lambda=9.6864021663644795e-09 > > > > 46 SNES Function norm 1.144804974438e+02 > > > > 0 KSP Residual norm 8.345139428850e+03 > > > > 1 KSP Residual norm 1.027819754739e-09 > > > > Line search: gnorm after quadratic fit 1.061319903906e+11 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.325012985379e+10 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.652236226640e+09 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.055533971630e+08 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.546607716763e+07 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.134442858835e+06 lambda=3.1250000000000002e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.839168570687e+05 lambda=1.5625000000000001e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.830568178626e+04 lambda=7.8125000000000004e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.201776786081e+03 lambda=3.9062500000000002e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.540520468013e+03 lambda=1.9531250000000001e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.573504890506e+02 lambda=9.7656250000000005e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.516203908013e+02 lambda=3.2703670177372021e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.148480075676e+02 lambda=3.2703670177372022e-06 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144841475328e+02 lambda=3.2703670177372023e-07 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144805305720e+02 lambda=3.2703670177372021e-08 > > > > Line search: Cubically determined step, current gnorm 1.144804974367e+02 lambda=3.2703670177372025e-09 > > > > 47 SNES Function norm 1.144804974367e+02 > > > > 0 KSP Residual norm 4.668983500382e+03 > > > > 1 KSP Residual norm 1.398997665317e-09 > > > > Line search: gnorm after quadratic fit 1.865309565532e+10 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.336975299727e+09 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.934905088739e+08 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.704520478641e+07 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.728477809448e+06 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.193001670096e+05 lambda=3.1250000000000002e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.610673238239e+04 lambda=1.5625000000000001e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.354711683605e+04 lambda=7.8125000000000004e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.589557246433e+03 lambda=3.9062500000000002e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.367851970709e+02 lambda=1.9531250000000001e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.136930269795e+02 lambda=9.0316845802227864e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.172186635069e+02 lambda=1.5831613287181393e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.145074017254e+02 lambda=1.5831613287181394e-06 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144807499816e+02 lambda=1.5831613287181396e-07 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144804983345e+02 lambda=1.5831613287181397e-08 > > > > Line search: Cubically determined step, current gnorm 1.144804971346e+02 lambda=5.2932921109871310e-09 > > > > 48 SNES Function norm 1.144804971346e+02 > > > > 0 KSP Residual norm 1.132678078317e+04 > > > > 1 KSP Residual norm 2.477518733314e-10 > > > > Line search: gnorm after quadratic fit 2.654659022365e+11 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.315296223725e+10 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.136635677074e+09 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.152507060235e+08 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.397060094478e+07 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.898362012287e+06 lambda=3.1250000000000002e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.685179520906e+05 lambda=1.5625000000000001e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.194040779842e+05 lambda=7.8125000000000004e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.606415730227e+04 lambda=3.9062500000000002e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.902698091972e+03 lambda=1.9531250000000001e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.521549384652e+02 lambda=9.7656250000000005e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.288999778994e+02 lambda=4.1899746703195281e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.157880829786e+02 lambda=4.5470218451893824e-06 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144935741206e+02 lambda=4.5470218451893828e-07 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144806232638e+02 lambda=4.5470218451893831e-08 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144804979250e+02 lambda=4.5470218451893835e-09 > > > > Line search: Cubically determined step, current gnorm 1.144804970825e+02 lambda=9.0293679903918216e-10 > > > > 49 SNES Function norm 1.144804970825e+02 > > > > 0 KSP Residual norm 2.712544829144e+04 > > > > 1 KSP Residual norm 4.949246309677e-09 > > > > Line search: gnorm after quadratic fit 3.650846005745e+12 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.565321055911e+11 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.711080201118e+10 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.150022242308e+09 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.965954117985e+08 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.128096393645e+08 lambda=3.1250000000000002e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.429702091584e+07 lambda=1.5625000000000001e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.841819946536e+06 lambda=7.8125000000000004e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.465032956946e+05 lambda=3.9062500000000002e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.594210253794e+04 lambda=1.9531250000000001e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.141110278944e+03 lambda=9.7656250000000005e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.306952279045e+03 lambda=4.8828125000000003e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.754164864338e+02 lambda=2.4414062500000001e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.476861367158e+02 lambda=9.2451761406722810e-06 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.147929263780e+02 lambda=9.2451761406722810e-07 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144836022952e+02 lambda=9.2451761406722821e-08 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144805271860e+02 lambda=9.2451761406722831e-09 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144804972895e+02 lambda=9.2451761406722839e-10 > > > > Line search: Cubically determined step, current gnorm 1.144804970737e+02 lambda=1.5633616333063305e-10 > > > > 50 SNES Function norm 1.144804970737e+02 > > > > 0 SNES Function norm 2.308693894796e+03 > > > > 0 KSP Residual norm 8.981999720532e+00 > > > > 1 KSP Residual norm 2.363170936183e-13 > > > > Line search: Using full step: fnorm 2.308693894796e+03 gnorm 7.571661187318e+02 > > > > 1 SNES Function norm 7.571661187318e+02 > > > > 0 KSP Residual norm 2.149614048903e+00 > > > > 1 KSP Residual norm 9.511247057888e-13 > > > > Line search: Using full step: fnorm 7.571661187318e+02 gnorm 4.450081004997e+02 > > > > 2 SNES Function norm 4.450081004997e+02 > > > > 0 KSP Residual norm 1.706469075123e+01 > > > > 1 KSP Residual norm 5.803815175472e-13 > > > > Line search: gnorm after quadratic fit 1.510518198899e+03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.850796532980e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.515983139755e+02 lambda=2.0602556887689423e-02 > > > > Line search: Cubically determined step, current gnorm 4.434800867235e+02 lambda=8.2396279492937211e-03 > > > > 3 SNES Function norm 4.434800867235e+02 > > > > 0 KSP Residual norm 3.208587171626e+00 > > > > 1 KSP Residual norm 1.099072610659e-13 > > > > Line search: gnorm after quadratic fit 4.080637194736e+02 > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > 4 SNES Function norm 4.080637194736e+02 > > > > 0 KSP Residual norm 8.136557176540e+00 > > > > 1 KSP Residual norm 8.800137844173e-13 > > > > Line search: gnorm after quadratic fit 5.261656549654e+02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.131114070934e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm 4.031614746044e+02 lambda=2.4674842039461482e-02 > > > > 5 SNES Function norm 4.031614746044e+02 > > > > 0 KSP Residual norm 7.609918907567e+00 > > > > 1 KSP Residual norm 1.613159932655e-13 > > > > Line search: gnorm after quadratic fit 5.353908064984e+02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.110480554132e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm 3.991168240716e+02 lambda=2.3079500036735322e-02 > > > > 6 SNES Function norm 3.991168240716e+02 > > > > 0 KSP Residual norm 3.800845472041e+00 > > > > 1 KSP Residual norm 4.841682188278e-13 > > > > Line search: gnorm after quadratic fit 3.787886582952e+02 > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > 7 SNES Function norm 3.787886582952e+02 > > > > 0 KSP Residual norm 1.892621919219e+00 > > > > 1 KSP Residual norm 3.576655371800e-12 > > > > Line search: gnorm after quadratic fit 3.440181918909e+02 > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > 8 SNES Function norm 3.440181918909e+02 > > > > 0 KSP Residual norm 3.559759789147e+00 > > > > 1 KSP Residual norm 8.347521826622e-13 > > > > Line search: gnorm after quadratic fit 3.287993515195e+02 > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > 9 SNES Function norm 3.287993515195e+02 > > > > 0 KSP Residual norm 1.825073540507e+00 > > > > 1 KSP Residual norm 8.352745008123e-14 > > > > Line search: Using full step: fnorm 3.287993515195e+02 gnorm 2.710650507416e+02 > > > > 10 SNES Function norm 2.710650507416e+02 > > > > 0 KSP Residual norm 7.568432945608e-01 > > > > 1 KSP Residual norm 2.780715252274e-14 > > > > Line search: Using full step: fnorm 2.710650507416e+02 gnorm 1.513359047342e+02 > > > > 11 SNES Function norm 1.513359047342e+02 > > > > 0 KSP Residual norm 9.387460484575e+00 > > > > 1 KSP Residual norm 7.091233040676e-13 > > > > Line search: gnorm after quadratic fit 3.998857979851e+02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.060972049714e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm 1.512140169420e+02 lambda=5.4338709720680610e-03 > > > > 12 SNES Function norm 1.512140169420e+02 > > > > 0 KSP Residual norm 4.399424360499e+00 > > > > 1 KSP Residual norm 1.614362118182e-13 > > > > Line search: gnorm after quadratic fit 1.913552832643e+02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.559719302467e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm 1.499985374733e+02 lambda=1.7102027220313589e-02 > > > > 13 SNES Function norm 1.499985374733e+02 > > > > 0 KSP Residual norm 3.740397849742e+00 > > > > 1 KSP Residual norm 8.986775577006e-13 > > > > Line search: gnorm after quadratic fit 1.764118876632e+02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.522381536119e+02 lambda=4.8196830215713270e-02 > > > > Line search: Cubically determined step, current gnorm 1.486175880390e+02 lambda=1.8881300948189364e-02 > > > > 14 SNES Function norm 1.486175880390e+02 > > > > 0 KSP Residual norm 6.067973818528e+00 > > > > 1 KSP Residual norm 4.527845229549e-13 > > > > Line search: gnorm after quadratic fit 2.514021299115e+02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.679972156573e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm 1.481015724304e+02 lambda=9.0116621678703428e-03 > > > > 15 SNES Function norm 1.481015724304e+02 > > > > 0 KSP Residual norm 6.108754994263e+00 > > > > 1 KSP Residual norm 2.557635976440e-13 > > > > Line search: gnorm after quadratic fit 2.458081150104e+02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.681837029397e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm 1.476148340442e+02 lambda=7.9580911933571953e-03 > > > > 16 SNES Function norm 1.476148340442e+02 > > > > 0 KSP Residual norm 7.914946163932e+00 > > > > 1 KSP Residual norm 1.512066885699e-13 > > > > Line search: gnorm after quadratic fit 3.458938604598e+02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.883018868359e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm 1.474286108114e+02 lambda=6.7262521208543979e-03 > > > > 17 SNES Function norm 1.474286108114e+02 > > > > 0 KSP Residual norm 5.285449532689e+00 > > > > 1 KSP Residual norm 6.693733977456e-12 > > > > Line search: gnorm after quadratic fit 2.170263102661e+02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.607560548008e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm 1.467785507822e+02 lambda=9.9244383205188240e-03 > > > > 18 SNES Function norm 1.467785507822e+02 > > > > 0 KSP Residual norm 8.124903695635e+00 > > > > 1 KSP Residual norm 2.322439601127e-11 > > > > Line search: gnorm after quadratic fit 3.589716592364e+02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.907315184877e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm 1.466341888638e+02 lambda=6.5538271222582893e-03 > > > > 19 SNES Function norm 1.466341888638e+02 > > > > 0 KSP Residual norm 5.253550718343e+00 > > > > 1 KSP Residual norm 1.575657996883e-12 > > > > Line search: gnorm after quadratic fit 2.155795776725e+02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.598564001687e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm 1.459869404602e+02 lambda=9.9195822632931301e-03 > > > > 20 SNES Function norm 1.459869404602e+02 > > > > 0 KSP Residual norm 8.405987790193e+00 > > > > 1 KSP Residual norm 2.046159481178e-13 > > > > Line search: gnorm after quadratic fit 3.767908298426e+02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.941885062002e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm 1.458995232755e+02 lambda=6.4359684554015136e-03 > > > > 21 SNES Function norm 1.458995232755e+02 > > > > 0 KSP Residual norm 5.036348246593e+00 > > > > 1 KSP Residual norm 3.645081669075e-13 > > > > Line search: gnorm after quadratic fit 2.083222977519e+02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.575737508694e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm 1.452039802458e+02 lambda=1.0554092389542354e-02 > > > > 22 SNES Function norm 1.452039802458e+02 > > > > 0 KSP Residual norm 8.562292355998e+00 > > > > 1 KSP Residual norm 3.256332645483e-13 > > > > Line search: gnorm after quadratic fit 3.869470823355e+02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.959483128249e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm 1.451523830598e+02 lambda=6.3780526507799607e-03 > > > > 23 SNES Function norm 1.451523830598e+02 > > > > 0 KSP Residual norm 4.919667503862e+00 > > > > 1 KSP Residual norm 4.823931177115e-13 > > > > Line search: gnorm after quadratic fit 2.042891039525e+02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.560623102934e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm 1.444331916523e+02 lambda=1.0890355421223689e-02 > > > > 24 SNES Function norm 1.444331916523e+02 > > > > 0 KSP Residual norm 8.727282395369e+00 > > > > 1 KSP Residual norm 7.090683582186e-13 > > > > Line search: gnorm after quadratic fit 3.977929422821e+02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.978556223200e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm 1.444215965394e+02 lambda=6.3477766966048947e-03 > > > > 25 SNES Function norm 1.444215965394e+02 > > > > 0 KSP Residual norm 4.759732971179e+00 > > > > 1 KSP Residual norm 7.539889498211e-13 > > > > Line search: gnorm after quadratic fit 1.990589649135e+02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.542648241555e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm 1.436629416941e+02 lambda=1.1434720389464151e-02 > > > > 26 SNES Function norm 1.436629416941e+02 > > > > 0 KSP Residual norm 8.844861828477e+00 > > > > 1 KSP Residual norm 4.372001279689e-13 > > > > Line search: gnorm after quadratic fit 4.055598972133e+02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.990820671396e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.436827663113e+02 lambda=6.3302081701296859e-03 > > > > Line search: Cubically determined step, current gnorm 1.434397789472e+02 lambda=3.1285674619640730e-03 > > > > 27 SNES Function norm 1.434397789472e+02 > > > > 0 KSP Residual norm 2.168630760128e+01 > > > > 1 KSP Residual norm 3.975838928402e-13 > > > > Line search: gnorm after quadratic fit 1.655681371309e+03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.972331169594e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.804118272840e+02 lambda=1.6710557456633125e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.435928635079e+02 lambda=1.6710557456633126e-03 > > > > Line search: Cubically determined step, current gnorm 1.434032742903e+02 lambda=5.1357350159978810e-04 > > > > 28 SNES Function norm 1.434032742903e+02 > > > > 0 KSP Residual norm 5.259508821923e+01 > > > > 1 KSP Residual norm 1.358381204928e-11 > > > > Line search: gnorm after quadratic fit 1.908330224731e+04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.431279702545e+03 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.060945045253e+02 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.791318323447e+02 lambda=1.2124172979783788e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.491140019897e+02 lambda=2.6952165802905347e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434246250245e+02 lambda=2.6952165802905350e-04 > > > > Line search: Cubically determined step, current gnorm 1.433970449422e+02 lambda=8.6980371578986910e-05 > > > > 29 SNES Function norm 1.433970449422e+02 > > > > 0 KSP Residual norm 1.326287161615e+02 > > > > 1 KSP Residual norm 5.692176796134e-12 > > > > Line search: gnorm after quadratic fit 2.077891749832e+05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.654187989332e+04 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.213029457851e+03 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.001385334742e+03 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.323976827250e+02 lambda=5.9607661619885998e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.489839529892e+02 lambda=1.0476257410701045e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434396736634e+02 lambda=1.0476257410701046e-04 > > > > Line search: Cubically determined step, current gnorm 1.433960671821e+02 lambda=1.3664867646895530e-05 > > > > 30 SNES Function norm 1.433960671821e+02 > > > > 0 KSP Residual norm 3.320710360189e+02 > > > > 1 KSP Residual norm 1.365660123102e-11 > > > > Line search: gnorm after quadratic fit 3.597335441013e+06 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.714766420450e+05 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.566809766217e+04 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.038660363150e+04 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.026997416957e+03 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.382653551072e+02 lambda=3.1250000000000002e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.071747386385e+02 lambda=1.3384948046761360e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.439693866777e+02 lambda=1.3384948046761360e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434000505249e+02 lambda=1.3384948046761361e-05 > > > > Line search: Cubically determined step, current gnorm 1.433959111179e+02 lambda=2.1771867000079373e-06 > > > > 31 SNES Function norm 1.433959111179e+02 > > > > 0 KSP Residual norm 8.385024273664e+02 > > > > 1 KSP Residual norm 2.688330817732e-11 > > > > Line search: gnorm after quadratic fit 5.487352481970e+07 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.776642694838e+06 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.310551423141e+05 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.023322644608e+05 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.368662233379e+04 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.472194884015e+03 lambda=3.1250000000000002e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.718801059897e+02 lambda=1.5625000000000001e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.274234972424e+02 lambda=6.3064412238487922e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.442194384053e+02 lambda=6.3064412238487925e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434033578642e+02 lambda=6.3064412238487927e-06 > > > > Line search: Cubically determined step, current gnorm 1.433959042208e+02 lambda=6.3064412238487929e-07 > > > > 32 SNES Function norm 1.433959042208e+02 > > > > 0 KSP Residual norm 5.310191626867e+02 > > > > 1 KSP Residual norm 2.270033897601e-10 > > > > Line search: gnorm after quadratic fit 1.447633783740e+07 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.859761774309e+06 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.472992503503e+05 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.557594026810e+04 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.969012939380e+03 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.269212161982e+03 lambda=3.1250000000000002e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.859005100842e+02 lambda=1.5625000000000001e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.695095262046e+02 lambda=5.4509037994531233e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.436389958907e+02 lambda=5.4509037994531237e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433976258223e+02 lambda=5.4509037994531242e-06 > > > > Line search: Cubically determined step, current gnorm 1.433958431980e+02 lambda=8.5124820362933632e-07 > > > > 33 SNES Function norm 1.433958431980e+02 > > > > 0 KSP Residual norm 1.341142541825e+03 > > > > 1 KSP Residual norm 4.194815344365e-11 > > > > Line search: gnorm after quadratic fit 2.256410317099e+08 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.797696259877e+07 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.447237377751e+06 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.221898175722e+05 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.260244723327e+04 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.539148524881e+03 lambda=3.1250000000000002e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.558034531173e+03 lambda=1.5625000000000001e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.788188892302e+02 lambda=7.8125000000000004e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.753621043454e+02 lambda=2.4427125599600652e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.437122397600e+02 lambda=2.4427125599600654e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433986985128e+02 lambda=2.4427125599600655e-06 > > > > Line search: Cubically determined step, current gnorm 1.433958402293e+02 lambda=2.4427125599600656e-07 > > > > 34 SNES Function norm 1.433958402293e+02 > > > > 0 KSP Residual norm 8.620962950418e+02 > > > > 1 KSP Residual norm 4.517777375659e-11 > > > > Line search: gnorm after quadratic fit 6.134442313460e+07 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.790495969255e+06 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.008365220843e+06 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.364572513478e+05 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.037891335918e+04 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.640571521199e+03 lambda=3.1250000000000002e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.472549649319e+02 lambda=1.5625000000000001e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.906041216274e+02 lambda=7.6348458761785112e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.504925859329e+02 lambda=1.7740973415567094e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434632637071e+02 lambda=1.7740973415567094e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433962847027e+02 lambda=1.7740973415567095e-06 > > > > Line search: Cubically determined step, current gnorm 1.433958170795e+02 lambda=3.2293255704969003e-07 > > > > 35 SNES Function norm 1.433958170795e+02 > > > > 0 KSP Residual norm 2.177497039945e+03 > > > > 1 KSP Residual norm 8.546235181505e-11 > > > > Line search: gnorm after quadratic fit 9.689178330938e+08 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.204850731541e+08 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.491460480376e+07 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.833699292784e+06 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.246639021599e+05 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.860166571872e+04 lambda=3.1250000000000002e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.484329051490e+03 lambda=1.5625000000000001e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.050411687443e+03 lambda=7.8125000000000004e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.488366972009e+02 lambda=3.7767265396089055e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.508326035050e+02 lambda=7.2725649346261757e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434696063559e+02 lambda=7.2725649346261764e-06 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433964618996e+02 lambda=7.2725649346261768e-07 > > > > Line search: Cubically determined step, current gnorm 1.433958141405e+02 lambda=7.2725649346261771e-08 > > > > 36 SNES Function norm 1.433958141405e+02 > > > > 0 KSP Residual norm 2.164813477994e+03 > > > > 1 KSP Residual norm 1.148881458292e-10 > > > > Line search: gnorm after quadratic fit 9.626940870744e+08 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.210459267934e+08 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.531855101756e+07 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.966826097072e+06 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.611808255272e+05 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.746062783262e+04 lambda=3.1250000000000002e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.252259871244e+03 lambda=1.5625000000000001e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.319447372021e+03 lambda=7.8125000000000004e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.963055448218e+02 lambda=3.9062500000000002e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.719034797105e+02 lambda=1.3935000445038475e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.436664111092e+02 lambda=1.3935000445038476e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433983336239e+02 lambda=1.3935000445038476e-06 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958213497e+02 lambda=1.3935000445038476e-07 > > > > Line search: Cubically determined step, current gnorm 1.433958104705e+02 lambda=5.1202466521517630e-08 > > > > 37 SNES Function norm 1.433958104705e+02 > > > > 0 KSP Residual norm 5.470482746849e+03 > > > > 1 KSP Residual norm 2.077456833170e-10 > > > > Line search: gnorm after quadratic fit 1.541335606193e+10 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.922526157954e+09 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.393079394383e+08 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.967573549050e+07 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.657319925168e+06 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.479516204895e+05 lambda=3.1250000000000002e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.573399122917e+04 lambda=1.5625000000000001e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.931177424479e+03 lambda=7.8125000000000004e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.619710606187e+03 lambda=3.9062500000000002e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.924551713717e+02 lambda=1.9531250000000001e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.786095404459e+02 lambda=6.2808469554243522e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.437467476469e+02 lambda=6.2808469554243527e-06 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433992463439e+02 lambda=6.2808469554243527e-07 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958367271e+02 lambda=6.2808469554243525e-08 > > > > Line search: Cubically determined step, current gnorm 1.433958098948e+02 lambda=8.0208105170108588e-09 > > > > 38 SNES Function norm 1.433958098948e+02 > > > > 0 KSP Residual norm 1.380568582849e+04 > > > > 1 KSP Residual norm 3.830866223513e-10 > > > > Line search: gnorm after quadratic fit 2.484973518314e+11 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.108953896984e+10 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.893104137528e+09 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.884003910853e+08 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.150765563542e+07 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.811161146103e+06 lambda=3.1250000000000002e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.011017986781e+06 lambda=1.5625000000000001e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.368084343451e+05 lambda=7.8125000000000004e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.042876665700e+04 lambda=3.9062500000000002e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.648735196752e+03 lambda=1.9531250000000001e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.489051252413e+02 lambda=9.7656250000000005e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.910677756717e+02 lambda=4.7728537787817724e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.505452645186e+02 lambda=1.1099980464343249e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434658984864e+02 lambda=1.1099980464343249e-06 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433964956476e+02 lambda=1.1099980464343249e-07 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958153212e+02 lambda=1.1099980464343250e-08 > > > > Line search: Cubically determined step, current gnorm 1.433958098048e+02 lambda=1.2587012037197021e-09 > > > > 39 SNES Function norm 1.433958098048e+02 > > > > 0 KSP Residual norm 3.492284741552e+04 > > > > 1 KSP Residual norm 2.459788921244e-09 > > > > Line search: gnorm after quadratic fit 4.017424324975e+12 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.020053801097e+11 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.270768402853e+10 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.827801904036e+09 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.758550488105e+08 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.213492627852e+08 lambda=3.1250000000000002e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.502191365805e+07 lambda=1.5625000000000001e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.846947104704e+06 lambda=7.8125000000000004e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.262850216093e+05 lambda=3.9062500000000002e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.879926646684e+04 lambda=1.9531250000000001e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.510203332079e+03 lambda=9.7656250000000005e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.055028679619e+03 lambda=4.8828125000000003e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.503903269554e+02 lambda=2.3633949212111800e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.510245991472e+02 lambda=4.5897967908360529e-06 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434724062782e+02 lambda=4.5897967908360533e-07 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433965706606e+02 lambda=4.5897967908360533e-08 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958168196e+02 lambda=4.5897967908360538e-09 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958098155e+02 lambda=4.5897967908360540e-10 > > > > Line search: Cubically determined step, current gnorm 1.433958097906e+02 lambda=1.9745369723997599e-10 > > > > 40 SNES Function norm 1.433958097906e+02 > > > > 0 KSP Residual norm 8.722495521587e+04 > > > > 1 KSP Residual norm 3.742695919275e-09 > > > > Line search: gnorm after quadratic fit 6.262538457180e+13 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.829256308992e+12 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.789282877890e+11 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.224340679566e+11 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.532137613500e+10 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.919506047737e+09 lambda=3.1250000000000002e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.410488718338e+08 lambda=1.5625000000000001e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.042211373104e+07 lambda=7.8125000000000004e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.881986305609e+06 lambda=3.9062500000000002e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.080857001861e+05 lambda=1.9531250000000001e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.054449734307e+04 lambda=9.7656250000000005e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.109051581397e+04 lambda=4.8828125000000003e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.144985497099e+03 lambda=2.4414062500000001e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.617627947761e+02 lambda=1.2207031250000001e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.132828960986e+02 lambda=5.3137869181552773e-06 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.440403409760e+02 lambda=5.3137869181552777e-07 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434022226216e+02 lambda=5.3137869181552781e-08 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958732177e+02 lambda=5.3137869181552781e-09 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958103569e+02 lambda=5.3137869181552779e-10 > > > > Line search: Cubically determined step, current gnorm 1.433958097894e+02 lambda=5.3137869181552781e-11 > > > > 41 SNES Function norm 1.433958097894e+02 > > > > 0 KSP Residual norm 6.453169081212e+04 > > > > 1 KSP Residual norm 2.762540688686e-09 > > > > Line search: gnorm after quadratic fit 2.535166112592e+13 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.168366990040e+12 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.958985371462e+11 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.945064622488e+10 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.172244865713e+09 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.693002384290e+08 lambda=3.1250000000000002e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.562568994785e+07 lambda=1.5625000000000001e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.182957296890e+07 lambda=7.8125000000000004e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.453260254263e+06 lambda=3.9062500000000002e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.781984147743e+05 lambda=1.9531250000000001e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.294934468515e+04 lambda=9.7656250000000005e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.740461720782e+03 lambda=4.8828125000000003e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.162621855154e+02 lambda=2.4414062500000001e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.042417294890e+02 lambda=1.1290474210136388e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.458920680477e+02 lambda=1.4201366604660443e-06 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434208620254e+02 lambda=1.4201366604660444e-07 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433960586269e+02 lambda=1.4201366604660445e-08 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958120934e+02 lambda=1.4201366604660445e-09 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958097940e+02 lambda=1.4201366604660446e-10 > > > > Line search: Cubically determined step, current gnorm 1.433958097852e+02 lambda=5.7981795207229486e-11 > > > > 42 SNES Function norm 1.433958097852e+02 > > > > 0 KSP Residual norm 1.596625793747e+05 > > > > 1 KSP Residual norm 6.465899717071e-09 > > > > Line search: gnorm after quadratic fit 3.840699863976e+14 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.801237514773e+13 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.002454410823e+12 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.505340831651e+11 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.387378188418e+10 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.174857842415e+10 lambda=3.1250000000000002e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.472211181784e+09 lambda=1.5625000000000001e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.849608933788e+08 lambda=7.8125000000000004e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.336592011613e+07 lambda=3.9062500000000002e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.988079805895e+06 lambda=1.9531250000000001e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.930858080425e+05 lambda=9.7656250000000005e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.521190722497e+04 lambda=4.8828125000000003e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.872153015323e+03 lambda=2.4414062500000001e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.772337662956e+03 lambda=1.2207031250000001e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.879470852054e+02 lambda=6.1035156250000003e-06 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.942774855488e+02 lambda=2.4957912736226801e-06 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.438719078958e+02 lambda=2.4957912736226800e-07 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434005516391e+02 lambda=2.4957912736226800e-08 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958568732e+02 lambda=2.4957912736226803e-09 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958102244e+02 lambda=2.4957912736226804e-10 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958097865e+02 lambda=2.4957912736226805e-11 > > > > Line search: Cubically determined step, current gnorm 1.433958097846e+02 lambda=9.2900433293108317e-12 > > > > 43 SNES Function norm 1.433958097846e+02 > > > > 0 KSP Residual norm 4.230869747157e+05 > > > > 1 KSP Residual norm 2.238707423027e-08 > > > > Line search: gnorm after quadratic fit 7.145700515048e+15 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.931871281700e+14 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.116420341041e+14 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.395366610168e+13 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.743811756566e+12 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.178776103292e+11 lambda=3.1250000000000002e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.721012032848e+10 lambda=1.5625000000000001e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.395186924428e+09 lambda=7.8125000000000004e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.229125978585e+08 lambda=3.9062500000000002e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.250971135953e+07 lambda=1.9531250000000001e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.483856203094e+06 lambda=9.7656250000000005e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.950671355228e+05 lambda=4.8828125000000003e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.795408218555e+04 lambda=2.4414062500000001e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.315025696280e+04 lambda=1.2207031250000001e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.395961070555e+03 lambda=6.1035156250000003e-06 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.565070307576e+02 lambda=3.0517578125000002e-06 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.228949713871e+02 lambda=1.2154989071946628e-06 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.441831998014e+02 lambda=1.2154989071946629e-07 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434037055996e+02 lambda=1.2154989071946630e-08 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958886074e+02 lambda=1.2154989071946630e-09 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958105564e+02 lambda=1.2154989071946630e-10 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958097907e+02 lambda=1.2154989071946631e-11 > > > > Line search: Cubically determined step, current gnorm 1.433958097845e+02 lambda=1.3559489351735629e-12 > > > > 44 SNES Function norm 1.433958097845e+02 > > > > 0 KSP Residual norm 1.017589039922e+06 > > > > 1 KSP Residual norm 5.483283808994e-08 > > > > Line search: gnorm after quadratic fit 9.942386816509e+16 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.242813073279e+16 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.553553149772e+15 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.942033483320e+14 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.427772097758e+13 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.035291372732e+12 lambda=3.1250000000000002e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.795558047824e+11 lambda=1.5625000000000001e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.748073147307e+10 lambda=7.8125000000000004e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.944235240368e+09 lambda=3.9062500000000002e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.453550734860e+08 lambda=1.9531250000000001e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.377045707707e+07 lambda=9.7656250000000005e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.188119937132e+07 lambda=4.8828125000000003e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.529730353136e+06 lambda=2.4414062500000001e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.044646611329e+05 lambda=1.2207031250000001e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.974477616118e+04 lambda=6.1035156250000003e-06 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.087923877078e+03 lambda=3.0517578125000002e-06 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.112257173311e+03 lambda=1.5258789062500001e-06 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.536190077033e+02 lambda=7.6293945312500004e-07 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.622567424729e+02 lambda=2.4244966960965791e-07 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.435780438142e+02 lambda=2.4244966960965793e-08 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433976282603e+02 lambda=2.4244966960965796e-09 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958279382e+02 lambda=2.4244966960965797e-10 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958099632e+02 lambda=2.4244966960965799e-11 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958097860e+02 lambda=2.4244966960965801e-12 > > > > Line search: Cubically determined step, current gnorm 1.433958097845e+02 lambda=2.4244966960965801e-13 > > > > 45 SNES Function norm 1.433958097845e+02 > > > > 0 KSP Residual norm 2.206687220910e+06 > > > > 1 KSP Residual norm 4.897651438902e-08 > > > > Line search: gnorm after quadratic fit 1.013883843512e+18 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.267347883019e+17 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.584167551460e+16 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.980166189110e+15 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.475099638694e+14 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.093604443378e+13 lambda=3.1250000000000002e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.866330988164e+12 lambda=1.5625000000000001e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.831230804145e+11 lambda=7.8125000000000004e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.034848618023e+10 lambda=3.9062500000000002e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.533173457427e+09 lambda=1.9531250000000001e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.390937545910e+08 lambda=9.7656250000000005e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.167706366282e+08 lambda=4.8828125000000003e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.445357932595e+07 lambda=2.4414062500000001e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.776833600920e+06 lambda=1.2207031250000001e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.177171496134e+05 lambda=6.1035156250000003e-06 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.775750596740e+04 lambda=3.0517578125000002e-06 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.374283858049e+03 lambda=1.5258789062500001e-06 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.030949543491e+03 lambda=7.6293945312500004e-07 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.423064811256e+02 lambda=3.6673216108643130e-07 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.499924205417e+02 lambda=6.7541706529544844e-08 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434620968378e+02 lambda=6.7541706529544851e-09 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433964732224e+02 lambda=6.7541706529544853e-10 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958164087e+02 lambda=6.7541706529544856e-11 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958098496e+02 lambda=6.7541706529544860e-12 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958097850e+02 lambda=6.7541706529544869e-13 > > > > Line search: unable to find good step length! After 24 tries > > > > Line search: fnorm=1.4339580978447020e+02, gnorm=1.4339580978501337e+02, ynorm=2.2066872446260620e+06, minlambda=9.9999999999999998e-13, lambda=6.7541706529544869e-13, initial slope=-2.0562359199040133e+04 > > > > 0 SNES Function norm 7.494832241120e+03 > > > > 0 KSP Residual norm 2.096735360816e+01 > > > > 1 KSP Residual norm 1.310027756820e-12 > > > > Line search: gnorm after quadratic fit 6.728375857515e+03 > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > 1 SNES Function norm 6.728375857515e+03 > > > > 0 KSP Residual norm 2.051806116405e+01 > > > > 1 KSP Residual norm 4.624620138831e-13 > > > > Line search: gnorm after quadratic fit 6.028616261650e+03 > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > 2 SNES Function norm 6.028616261650e+03 > > > > 0 KSP Residual norm 2.416503160016e+01 > > > > 1 KSP Residual norm 8.456041680630e-13 > > > > Line search: gnorm after quadratic fit 5.407473517447e+03 > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > 3 SNES Function norm 5.407473517447e+03 > > > > 0 KSP Residual norm 1.429873750399e+01 > > > > 1 KSP Residual norm 2.956316145819e-13 > > > > Line search: Using full step: fnorm 5.407473517447e+03 gnorm 1.894530516076e+03 > > > > 4 SNES Function norm 1.894530516076e+03 > > > > 0 KSP Residual norm 2.898580554597e+00 > > > > 1 KSP Residual norm 6.622560162623e-14 > > > > Line search: Using full step: fnorm 1.894530516076e+03 gnorm 1.794029421846e+03 > > > > 5 SNES Function norm 1.794029421846e+03 > > > > 0 KSP Residual norm 1.749678611959e+01 > > > > 1 KSP Residual norm 8.138905825078e-12 > > > > Line search: gnorm after quadratic fit 1.767361408940e+03 > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > 6 SNES Function norm 1.767361408940e+03 > > > > 0 KSP Residual norm 1.094404109423e+02 > > > > 1 KSP Residual norm 7.696691527700e-12 > > > > Line search: gnorm after quadratic fit 3.545750923895e+04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.153479540314e+03 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.205683629874e+03 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.802976525485e+03 lambda=1.2441094586006883e-02 > > > > Line search: Cubically determined step, current gnorm 1.765063299263e+03 lambda=4.9240328094708914e-03 > > > > 7 SNES Function norm 1.765063299263e+03 > > > > 0 KSP Residual norm 1.778095975189e+01 > > > > 1 KSP Residual norm 2.814661813934e-12 > > > > Line search: gnorm after quadratic fit 2.620761680117e+03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.793045753271e+03 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm 1.740299227935e+03 lambda=2.5000000000000001e-02 > > > > 8 SNES Function norm 1.740299227935e+03 > > > > 0 KSP Residual norm 3.284236894535e+02 > > > > 1 KSP Residual norm 5.172103783952e-10 > > > > Line search: gnorm after quadratic fit 2.857820523902e+05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.063993491139e+04 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.588139591650e+03 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.491163684413e+03 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.802614760566e+03 lambda=5.7977212395253904e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.741444490992e+03 lambda=1.8448315876950813e-03 > > > > Line search: Cubically determined step, current gnorm 1.739663656043e+03 lambda=7.7468345598227730e-04 > > > > 9 SNES Function norm 1.739663656043e+03 > > > > 0 KSP Residual norm 4.581839103558e+02 > > > > 1 KSP Residual norm 2.627035885943e-11 > > > > Line search: gnorm after quadratic fit 8.199478499066e+05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.127270076812e+05 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.816774161281e+04 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.053723877333e+03 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.971814513392e+03 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.755066208174e+03 lambda=2.7232010924558834e-03 > > > > Line search: Cubically determined step, current gnorm 1.739559834479e+03 lambda=8.1458417855297680e-04 > > > > 10 SNES Function norm 1.739559834479e+03 > > > > 0 KSP Residual norm 1.463056810139e+02 > > > > 1 KSP Residual norm 5.383584598825e-12 > > > > Line search: gnorm after quadratic fit 2.885699620595e+04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.847717401708e+03 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.244464170034e+03 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.769157604338e+03 lambda=1.0857209099577540e-02 > > > > Line search: Cubically determined step, current gnorm 1.737356225452e+03 lambda=4.0312937622950231e-03 > > > > 11 SNES Function norm 1.737356225452e+03 > > > > 0 KSP Residual norm 1.564105677925e+02 > > > > 1 KSP Residual norm 6.671164745832e-11 > > > > Line search: gnorm after quadratic fit 3.815800291873e+04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.197027796134e+03 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.373151605545e+03 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.783976520867e+03 lambda=1.2093374970461970e-02 > > > > Line search: Cubically determined step, current gnorm 1.735737929915e+03 lambda=4.9529698477569920e-03 > > > > 12 SNES Function norm 1.735737929915e+03 > > > > 0 KSP Residual norm 5.030757139645e+01 > > > > 1 KSP Residual norm 1.157542730692e-12 > > > > Line search: gnorm after quadratic fit 3.004544441458e+03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.850403239750e+03 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm 1.722893188305e+03 lambda=2.0881992439921702e-02 > > > > 13 SNES Function norm 1.722893188305e+03 > > > > 0 KSP Residual norm 7.123428853845e+01 > > > > 1 KSP Residual norm 8.671726774894e-12 > > > > Line search: gnorm after quadratic fit 4.361041499279e+03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.032697222107e+03 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.726212330814e+03 lambda=1.9909470348267504e-02 > > > > Line search: Cubically determined step, current gnorm 1.714127356920e+03 lambda=9.9547351741337518e-03 > > > > 14 SNES Function norm 1.714127356920e+03 > > > > 0 KSP Residual norm 8.304557447257e+00 > > > > 1 KSP Residual norm 6.268295862688e-13 > > > > Line search: gnorm after quadratic fit 1.558163002487e+03 > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > 15 SNES Function norm 1.558163002487e+03 > > > > 0 KSP Residual norm 2.820803287164e+00 > > > > 1 KSP Residual norm 5.477413853752e-13 > > > > Line search: gnorm after quadratic fit 1.065673478530e+03 > > > > Line search: Quadratically determined step, lambda=3.8943438938591052e-01 > > > > 16 SNES Function norm 1.065673478530e+03 > > > > 0 KSP Residual norm 2.296739120664e+00 > > > > 1 KSP Residual norm 6.273731899885e-14 > > > > Line search: gnorm after quadratic fit 8.964342150621e+02 > > > > Line search: Quadratically determined step, lambda=1.8740736900935545e-01 > > > > 17 SNES Function norm 8.964342150621e+02 > > > > 0 KSP Residual norm 5.567568505830e+00 > > > > 1 KSP Residual norm 8.649083600764e-12 > > > > Line search: gnorm after quadratic fit 8.322514858992e+02 > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > 18 SNES Function norm 8.322514858992e+02 > > > > 0 KSP Residual norm 1.164393577210e+00 > > > > 1 KSP Residual norm 2.019248309015e-14 > > > > Line search: Using full step: fnorm 8.322514858992e+02 gnorm 3.179750274746e+02 > > > > 19 SNES Function norm 3.179750274746e+02 > > > > 0 KSP Residual norm 5.339294310641e+00 > > > > 1 KSP Residual norm 2.070321587238e-13 > > > > Line search: gnorm after quadratic fit 3.433012316833e+02 > > > > Line search: Cubically determined step, current gnorm 3.140305403821e+02 lambda=5.0000000000000003e-02 > > > > 20 SNES Function norm 3.140305403821e+02 > > > > 0 KSP Residual norm 1.177016565578e+01 > > > > 1 KSP Residual norm 2.413027540446e-13 > > > > Line search: gnorm after quadratic fit 7.377851778409e+02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.896721016582e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm 3.136619309181e+02 lambda=9.7219892278716195e-03 > > > > 21 SNES Function norm 3.136619309181e+02 > > > > 0 KSP Residual norm 3.973565083977e+00 > > > > 1 KSP Residual norm 9.726786674410e-14 > > > > Line search: gnorm after quadratic fit 3.098277326090e+02 > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > 22 SNES Function norm 3.098277326090e+02 > > > > 0 KSP Residual norm 9.389290683519e+00 > > > > 1 KSP Residual norm 1.651497163724e-13 > > > > Line search: gnorm after quadratic fit 6.887970540455e+02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.588146381477e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.099274823603e+02 lambda=1.6890426151283184e-02 > > > > Line search: Cubically determined step, current gnorm 3.084890760827e+02 lambda=8.4452130756415920e-03 > > > > 23 SNES Function norm 3.084890760827e+02 > > > > 0 KSP Residual norm 2.381130479641e+00 > > > > 1 KSP Residual norm 4.694489283156e-14 > > > > Line search: gnorm after quadratic fit 2.872151876535e+02 > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > 24 SNES Function norm 2.872151876535e+02 > > > > 0 KSP Residual norm 2.405498502269e+00 > > > > 1 KSP Residual norm 3.316846070538e-13 > > > > Line search: gnorm after quadratic fit 2.686789761232e+02 > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > 25 SNES Function norm 2.686789761232e+02 > > > > 0 KSP Residual norm 1.728772970554e+00 > > > > 1 KSP Residual norm 4.132974383339e-14 > > > > Line search: gnorm after quadratic fit 2.365009918229e+02 > > > > Line search: Quadratically determined step, lambda=1.7273357529379074e-01 > > > > 26 SNES Function norm 2.365009918229e+02 > > > > 0 KSP Residual norm 4.413764759374e+00 > > > > 1 KSP Residual norm 5.210690816917e-14 > > > > Line search: gnorm after quadratic fit 2.756730968257e+02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.372321757171e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm 2.335020811250e+02 lambda=2.5000000000000001e-02 > > > > 27 SNES Function norm 2.335020811250e+02 > > > > 0 KSP Residual norm 1.606246507553e+00 > > > > 1 KSP Residual norm 3.564847846678e-14 > > > > Line search: gnorm after quadratic fit 2.078263630653e+02 > > > > Line search: Quadratically determined step, lambda=1.5913860995949433e-01 > > > > 28 SNES Function norm 2.078263630653e+02 > > > > 0 KSP Residual norm 3.700632954873e+00 > > > > 1 KSP Residual norm 5.113863400264e-13 > > > > Line search: gnorm after quadratic fit 2.142503514807e+02 > > > > Line search: Cubically determined step, current gnorm 2.021095009118e+02 lambda=5.0000000000000003e-02 > > > > 29 SNES Function norm 2.021095009118e+02 > > > > 0 KSP Residual norm 3.056449560135e+00 > > > > 1 KSP Residual norm 3.207987681334e-14 > > > > Line search: gnorm after quadratic fit 2.064252530802e+02 > > > > Line search: Cubically determined step, current gnorm 1.978069081639e+02 lambda=5.0000000000000003e-02 > > > > 30 SNES Function norm 1.978069081639e+02 > > > > 0 KSP Residual norm 2.024695620703e+00 > > > > 1 KSP Residual norm 5.460360737995e-14 > > > > Line search: gnorm after quadratic fit 1.839556530796e+02 > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > 31 SNES Function norm 1.839556530796e+02 > > > > 0 KSP Residual norm 1.610676619931e+01 > > > > 1 KSP Residual norm 6.703552136307e-13 > > > > Line search: gnorm after quadratic fit 7.186735314913e+02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.905672430097e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.856766286600e+02 lambda=1.0830798014298563e-02 > > > > Line search: Cubically determined step, current gnorm 1.836818937131e+02 lambda=3.3207362501459785e-03 > > > > 32 SNES Function norm 1.836818937131e+02 > > > > 0 KSP Residual norm 7.471722173131e+01 > > > > 1 KSP Residual norm 2.671534648829e-12 > > > > Line search: gnorm after quadratic fit 9.613379909411e+04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.509491298762e+04 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.808861367705e+03 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.767283758299e+02 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.665421328348e+02 lambda=6.0369453941238101e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.869726717041e+02 lambda=1.4394327006264963e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.836897704575e+02 lambda=1.4394327006264963e-04 > > > > Line search: Cubically determined step, current gnorm 1.836767951408e+02 lambda=5.5567420418543164e-05 > > > > 33 SNES Function norm 1.836767951408e+02 > > > > 0 KSP Residual norm 2.702367712138e+01 > > > > 1 KSP Residual norm 2.731656687850e-12 > > > > Line search: gnorm after quadratic fit 3.331563146098e+03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.723694790688e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.941243220944e+02 lambda=2.1443568774664485e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.847231733910e+02 lambda=2.7571330376860012e-03 > > > > Line search: Cubically determined step, current gnorm 1.836356729409e+02 lambda=4.7841280418270480e-04 > > > > 34 SNES Function norm 1.836356729409e+02 > > > > 0 KSP Residual norm 1.228333177997e+01 > > > > 1 KSP Residual norm 2.681127387880e-13 > > > > Line search: gnorm after quadratic fit 6.936329223475e+02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.749327218775e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.871557327742e+02 lambda=1.4160505301999991e-02 > > > > Line search: Cubically determined step, current gnorm 1.833523080682e+02 lambda=3.5196326548579192e-03 > > > > 35 SNES Function norm 1.833523080682e+02 > > > > 0 KSP Residual norm 3.531886257396e+02 > > > > 1 KSP Residual norm 2.364634092895e-11 > > > > Line search: gnorm after quadratic fit 3.994783047929e+06 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.753715960726e+05 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.516669898185e+04 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.918985942348e+03 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.363599250418e+03 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.344906818752e+02 lambda=3.1250000000000002e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.991088183980e+02 lambda=1.0108094710462592e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.834621681844e+02 lambda=1.0108094710462593e-04 > > > > Line search: Cubically determined step, current gnorm 1.833517377324e+02 lambda=1.0108094710462594e-05 > > > > 36 SNES Function norm 1.833517377324e+02 > > > > 0 KSP Residual norm 9.005833507118e+01 > > > > 1 KSP Residual norm 6.116387880629e-12 > > > > Line search: gnorm after quadratic fit 8.899847103226e+04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.388111536526e+04 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.532652074749e+03 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.864912734009e+02 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.421068789960e+02 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.873498120960e+02 lambda=2.1924025345283278e-03 > > > > Line search: Cubically determined step, current gnorm 1.833506987706e+02 lambda=2.1924025345283280e-04 > > > > 37 SNES Function norm 1.833506987706e+02 > > > > 0 KSP Residual norm 1.548426525207e+01 > > > > 1 KSP Residual norm 1.038038773942e-12 > > > > Line search: gnorm after quadratic fit 6.702848665441e+02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.789880616078e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.846521504351e+02 lambda=1.0567302644323170e-02 > > > > Line search: Cubically determined step, current gnorm 1.830548481815e+02 lambda=3.5274490352771972e-03 > > > > 38 SNES Function norm 1.830548481815e+02 > > > > 0 KSP Residual norm 1.523095478807e+01 > > > > 1 KSP Residual norm 1.963823596119e-12 > > > > Line search: gnorm after quadratic fit 9.255727478491e+02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.496757253461e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.863126241242e+02 lambda=9.3143291632966311e-03 > > > > Line search: Cubically determined step, current gnorm 1.829091761403e+02 lambda=1.8107234819462800e-03 > > > > 39 SNES Function norm 1.829091761403e+02 > > > > 0 KSP Residual norm 1.311320726934e+01 > > > > 1 KSP Residual norm 9.084170520902e-13 > > > > Line search: gnorm after quadratic fit 7.488610069188e+02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.691148243365e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.885558228772e+02 lambda=1.9439894235886539e-02 > > > > Line search: Cubically determined step, current gnorm 1.825540619134e+02 lambda=5.4967824488704169e-03 > > > > 40 SNES Function norm 1.825540619134e+02 > > > > 0 KSP Residual norm 1.218635557505e+01 > > > > 1 KSP Residual norm 7.760485728617e-13 > > > > Line search: gnorm after quadratic fit 6.636453826807e+02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.880828006022e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.830493790584e+02 lambda=6.6234802648049863e-03 > > > > Line search: Cubically determined step, current gnorm 1.823397545268e+02 lambda=2.4308217464828865e-03 > > > > 41 SNES Function norm 1.823397545268e+02 > > > > 0 KSP Residual norm 9.456543593865e+00 > > > > 1 KSP Residual norm 7.046593270309e-13 > > > > Line search: gnorm after quadratic fit 3.369769163110e+02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.105230957789e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm 1.817897533119e+02 lambda=9.1612481372917148e-03 > > > > 42 SNES Function norm 1.817897533119e+02 > > > > 0 KSP Residual norm 7.290035145805e+00 > > > > 1 KSP Residual norm 3.198962158141e-12 > > > > Line search: gnorm after quadratic fit 2.858311567415e+02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.965004842981e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm 1.808845577764e+02 lambda=1.3826421990147811e-02 > > > > 43 SNES Function norm 1.808845577764e+02 > > > > 0 KSP Residual norm 7.256785036157e+00 > > > > 1 KSP Residual norm 9.243179217625e-14 > > > > Line search: gnorm after quadratic fit 2.534388176390e+02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.916726818893e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm 1.797953125543e+02 lambda=1.3677747819164022e-02 > > > > 44 SNES Function norm 1.797953125543e+02 > > > > 0 KSP Residual norm 1.716201096352e+01 > > > > 1 KSP Residual norm 2.701418800808e-13 > > > > Line search: gnorm after quadratic fit 1.331064301474e+03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.461842246267e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.920668830294e+02 lambda=1.2856504859057132e-02 > > > > Line search: Cubically determined step, current gnorm 1.797121460957e+02 lambda=1.4396611381500967e-03 > > > > 45 SNES Function norm 1.797121460957e+02 > > > > 0 KSP Residual norm 6.613432967985e+00 > > > > 1 KSP Residual norm 1.357752977076e-13 > > > > Line search: gnorm after quadratic fit 2.721288927858e+02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.939638282615e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm 1.787985482018e+02 lambda=1.2647907914070569e-02 > > > > 46 SNES Function norm 1.787985482018e+02 > > > > 0 KSP Residual norm 1.225736349281e+01 > > > > 1 KSP Residual norm 3.819378790812e-13 > > > > Line search: gnorm after quadratic fit 4.548006065036e+02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.304803559060e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm 1.787344729174e+02 lambda=8.9002284237256531e-03 > > > > 47 SNES Function norm 1.787344729174e+02 > > > > 0 KSP Residual norm 6.302465402340e+00 > > > > 1 KSP Residual norm 6.980931947122e-14 > > > > Line search: gnorm after quadratic fit 2.879477700004e+02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.980806946742e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm 1.780128006935e+02 lambda=1.0223293444602008e-02 > > > > 48 SNES Function norm 1.780128006935e+02 > > > > 0 KSP Residual norm 4.323829277968e+00 > > > > 1 KSP Residual norm 5.223881369308e-13 > > > > Line search: gnorm after quadratic fit 1.957928151218e+02 > > > > Line search: Cubically determined step, current gnorm 1.768899805640e+02 lambda=5.0000000000000003e-02 > > > > 49 SNES Function norm 1.768899805640e+02 > > > > 0 KSP Residual norm 2.249256107033e+00 > > > > 1 KSP Residual norm 3.624400957270e-14 > > > > Line search: gnorm after quadratic fit 1.704782114773e+02 > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > 50 SNES Function norm 1.704782114773e+02 > > > > 0 SNES Function norm 3.513783397332e+03 > > > > 0 KSP Residual norm 1.650214950648e+01 > > > > 1 KSP Residual norm 3.574269752690e-13 > > > > Line search: gnorm after quadratic fit 3.155830404050e+03 > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > 1 SNES Function norm 3.155830404050e+03 > > > > 0 KSP Residual norm 1.443734018042e+01 > > > > 1 KSP Residual norm 3.685565191058e-13 > > > > Line search: Using full step: fnorm 3.155830404050e+03 gnorm 8.581212204155e+02 > > > > 2 SNES Function norm 8.581212204155e+02 > > > > 0 KSP Residual norm 2.492601775565e+00 > > > > 1 KSP Residual norm 9.698440210389e-14 > > > > Line search: Using full step: fnorm 8.581212204155e+02 gnorm 7.018609898542e+02 > > > > 3 SNES Function norm 7.018609898542e+02 > > > > 0 KSP Residual norm 1.740320986421e+00 > > > > 1 KSP Residual norm 2.868780682435e-14 > > > > Line search: Using full step: fnorm 7.018609898542e+02 gnorm 2.135824235887e+02 > > > > 4 SNES Function norm 2.135824235887e+02 > > > > 0 KSP Residual norm 1.647413497077e+00 > > > > 1 KSP Residual norm 2.731226225666e-14 > > > > Line search: gnorm after quadratic fit 1.936469032649e+02 > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > 5 SNES Function norm 1.936469032649e+02 > > > > 0 KSP Residual norm 1.406615972124e+00 > > > > 1 KSP Residual norm 3.167179626699e-14 > > > > Line search: gnorm after quadratic fit 1.755362571467e+02 > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > 6 SNES Function norm 1.755362571467e+02 > > > > 0 KSP Residual norm 1.480681706594e+00 > > > > 1 KSP Residual norm 2.935210968935e-14 > > > > Line search: gnorm after quadratic fit 1.597659506616e+02 > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > 7 SNES Function norm 1.597659506616e+02 > > > > 0 KSP Residual norm 4.013154698097e+00 > > > > 1 KSP Residual norm 1.021628704832e-13 > > > > Line search: gnorm after quadratic fit 1.728408060966e+02 > > > > Line search: Cubically determined step, current gnorm 1.570815760721e+02 lambda=5.0000000000000003e-02 > > > > 8 SNES Function norm 1.570815760721e+02 > > > > 0 KSP Residual norm 1.510335662636e+00 > > > > 1 KSP Residual norm 2.728243244724e-14 > > > > Line search: gnorm after quadratic fit 1.450162880692e+02 > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > 9 SNES Function norm 1.450162880692e+02 > > > > 0 KSP Residual norm 1.923349271077e+01 > > > > 1 KSP Residual norm 1.640711956406e-11 > > > > Line search: gnorm after quadratic fit 1.016537223115e+03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.584263092048e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.490729346583e+02 lambda=9.3725990358703350e-03 > > > > Line search: Cubically determined step, current gnorm 1.449349273006e+02 lambda=1.5464889706033082e-03 > > > > 10 SNES Function norm 1.449349273006e+02 > > > > 0 KSP Residual norm 1.154999084194e+01 > > > > 1 KSP Residual norm 1.292167633338e-11 > > > > Line search: gnorm after quadratic fit 6.060386918705e+02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.236630526035e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.491201927819e+02 lambda=1.6816056300124185e-02 > > > > Line search: Cubically determined step, current gnorm 1.447023047013e+02 lambda=4.1484374564153808e-03 > > > > 11 SNES Function norm 1.447023047013e+02 > > > > 0 KSP Residual norm 7.278906180502e+00 > > > > 1 KSP Residual norm 2.815632651924e-12 > > > > Line search: gnorm after quadratic fit 2.512278711773e+02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.624350957814e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm 1.441656049510e+02 lambda=1.0879389002513012e-02 > > > > 12 SNES Function norm 1.441656049510e+02 > > > > 0 KSP Residual norm 4.449836480267e+00 > > > > 1 KSP Residual norm 3.152365624813e-13 > > > > Line search: gnorm after quadratic fit 1.749680739878e+02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.458763435996e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm 1.425715025152e+02 lambda=2.2766809271842225e-02 > > > > 13 SNES Function norm 1.425715025152e+02 > > > > 0 KSP Residual norm 4.218495037726e+00 > > > > 1 KSP Residual norm 1.398472536142e-12 > > > > Line search: gnorm after quadratic fit 1.645159536467e+02 > > > > Line search: Cubically determined step, current gnorm 1.421991559212e+02 lambda=4.1883769431247941e-02 > > > > 14 SNES Function norm 1.421991559212e+02 > > > > 0 KSP Residual norm 1.968853538608e+00 > > > > 1 KSP Residual norm 7.594023450519e-12 > > > > Line search: gnorm after quadratic fit 1.350960142124e+02 > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > 15 SNES Function norm 1.350960142124e+02 > > > > 0 KSP Residual norm 3.444721686085e+00 > > > > 1 KSP Residual norm 5.312609674019e-14 > > > > Line search: gnorm after quadratic fit 1.472880565107e+02 > > > > Line search: Cubically determined step, current gnorm 1.336714620145e+02 lambda=4.1341550820829437e-02 > > > > 16 SNES Function norm 1.336714620145e+02 > > > > 0 KSP Residual norm 3.276288899397e+00 > > > > 1 KSP Residual norm 8.394674946715e-14 > > > > Line search: gnorm after quadratic fit 1.459274497150e+02 > > > > Line search: Cubically determined step, current gnorm 1.327618539486e+02 lambda=5.0000000000000003e-02 > > > > 17 SNES Function norm 1.327618539486e+02 > > > > 0 KSP Residual norm 2.630052244303e+00 > > > > 1 KSP Residual norm 4.351283410507e-14 > > > > Line search: gnorm after quadratic fit 1.350378060116e+02 > > > > Line search: Cubically determined step, current gnorm 1.299403903934e+02 lambda=4.9913529436269283e-02 > > > > 18 SNES Function norm 1.299403903934e+02 > > > > 0 KSP Residual norm 6.124953430138e+00 > > > > 1 KSP Residual norm 2.295381352938e-13 > > > > Line search: gnorm after quadratic fit 2.275621676963e+02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.469611730657e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm 1.294890694898e+02 lambda=1.0071939100661648e-02 > > > > 19 SNES Function norm 1.294890694898e+02 > > > > 0 KSP Residual norm 1.036733907011e+01 > > > > 1 KSP Residual norm 1.800941381283e-13 > > > > Line search: gnorm after quadratic fit 3.844879463595e+02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.875071148504e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm 1.294494430642e+02 lambda=5.0000000000000010e-03 > > > > 20 SNES Function norm 1.294494430642e+02 > > > > 0 KSP Residual norm 8.224001595443e+00 > > > > 1 KSP Residual norm 3.337810156182e-13 > > > > Line search: gnorm after quadratic fit 3.332325263497e+02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.682441841234e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.294720538860e+02 lambda=8.5401597581228530e-03 > > > > Line search: Cubically determined step, current gnorm 1.291762382985e+02 lambda=4.2555418164960989e-03 > > > > 21 SNES Function norm 1.291762382985e+02 > > > > 0 KSP Residual norm 3.920749219860e+01 > > > > 1 KSP Residual norm 1.610902886435e-12 > > > > Line search: gnorm after quadratic fit 3.472422440640e+03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.023065712859e+03 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.228184088700e+02 lambda=1.6004598823093592e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.298607525058e+02 lambda=1.6004598823093593e-03 > > > > Line search: Cubically determined step, current gnorm 1.291643460998e+02 lambda=1.9319076533745672e-04 > > > > 22 SNES Function norm 1.291643460998e+02 > > > > 0 KSP Residual norm 1.520092314848e+02 > > > > 1 KSP Residual norm 7.089159192434e-11 > > > > Line search: gnorm after quadratic fit 2.752539686422e+05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.237188995536e+04 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.484370498858e+03 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.571039994484e+03 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.280898858362e+02 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.708927009106e+02 lambda=2.6114913411793973e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.294919567784e+02 lambda=2.6114913411793975e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291645609810e+02 lambda=2.6114913411793977e-05 > > > > Line search: Cubically determined step, current gnorm 1.291635530596e+02 lambda=1.2278773895355162e-05 > > > > 23 SNES Function norm 1.291635530596e+02 > > > > 0 KSP Residual norm 7.569206058965e+02 > > > > 1 KSP Residual norm 3.454693729751e-11 > > > > Line search: gnorm after quadratic fit 2.570888738395e+07 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.064965025187e+06 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.498514098182e+05 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.807487005202e+04 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.233167830543e+03 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.396736912757e+03 lambda=3.1250000000000002e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.547572543330e+02 lambda=1.2623406091699435e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.335889024473e+02 lambda=1.8542137907683829e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.292059042479e+02 lambda=1.8542137907683831e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291637618568e+02 lambda=1.8542137907683832e-06 > > > > Line search: Cubically determined step, current gnorm 1.291635210734e+02 lambda=4.9524172913414387e-07 > > > > 24 SNES Function norm 1.291635210734e+02 > > > > 0 KSP Residual norm 3.761913422861e+03 > > > > 1 KSP Residual norm 6.181718776929e-10 > > > > Line search: gnorm after quadratic fit 3.342370445037e+09 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.218326646111e+08 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.375128803204e+07 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.980626157021e+06 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.407418671219e+05 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.357321025399e+05 lambda=3.1250000000000002e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.188948059047e+04 lambda=1.5625000000000001e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.105117929713e+03 lambda=7.8125000000000004e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.331054736818e+02 lambda=3.9062500000000002e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.942479792843e+02 lambda=1.9412500272460620e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.436944624694e+02 lambda=6.4483223307578726e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.292972287211e+02 lambda=6.4483223307578726e-06 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291647778160e+02 lambda=6.4483223307578730e-07 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635261433e+02 lambda=6.4483223307578730e-08 > > > > Line search: Cubically determined step, current gnorm 1.291635197798e+02 lambda=2.0042115918485846e-08 > > > > 25 SNES Function norm 1.291635197798e+02 > > > > 0 KSP Residual norm 1.874745766083e+04 > > > > 1 KSP Residual norm 1.476978150334e-09 > > > > Line search: gnorm after quadratic fit 4.089262111368e+11 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.101717203770e+10 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.352565940292e+09 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.879613196620e+08 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.698613558125e+07 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.175566265039e+07 lambda=3.1250000000000002e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.382919964952e+06 lambda=1.5625000000000001e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.545431975334e+05 lambda=7.8125000000000004e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.713561369103e+04 lambda=3.9062500000000002e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.031789308419e+03 lambda=1.9531250000000001e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.205847020738e+02 lambda=9.7656250000000005e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.957203153158e+02 lambda=2.8132879163728503e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.297923302791e+02 lambda=2.8132879163728504e-06 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291698100579e+02 lambda=2.8132879163728504e-07 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635794525e+02 lambda=2.8132879163728506e-08 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635200489e+02 lambda=2.8132879163728508e-09 > > > > Line search: Cubically determined step, current gnorm 1.291635197275e+02 lambda=8.0832061492461345e-10 > > > > 26 SNES Function norm 1.291635197275e+02 > > > > 0 KSP Residual norm 9.248381077528e+04 > > > > 1 KSP Residual norm 7.262307068447e-09 > > > > Line search: gnorm after quadratic fit 4.920647210624e+13 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.153216818065e+12 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.697543960375e+11 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.637004379805e+10 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.208402653149e+10 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.519988135798e+09 lambda=3.1250000000000002e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.923903214787e+08 lambda=1.5625000000000001e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.465663001976e+07 lambda=7.8125000000000004e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.238603967195e+06 lambda=3.9062500000000002e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.459179143177e+05 lambda=1.9531250000000001e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.676301042792e+04 lambda=9.7656250000000005e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.135808875752e+04 lambda=4.8828125000000003e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.275714918657e+03 lambda=2.4414062500000001e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.719037747616e+02 lambda=1.2207031250000001e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.039826156716e+02 lambda=5.5609199181402721e-06 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.308092967809e+02 lambda=9.1057337296683134e-07 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291796742824e+02 lambda=9.1057337296683134e-08 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291636800174e+02 lambda=9.1057337296683134e-09 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635212255e+02 lambda=9.1057337296683134e-10 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635197320e+02 lambda=9.1057337296683139e-11 > > > > Line search: Cubically determined step, current gnorm 1.291635197254e+02 lambda=3.2898162617097329e-11 > > > > 27 SNES Function norm 1.291635197254e+02 > > > > 0 KSP Residual norm 4.818745996826e+05 > > > > 1 KSP Residual norm 3.300979345194e-08 > > > > Line search: gnorm after quadratic fit 6.957046028867e+15 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.695654311477e+14 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.086793500688e+14 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.358083744813e+13 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.696584801696e+12 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.118183549773e+11 lambda=3.1250000000000002e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.641372080976e+10 lambda=1.5625000000000001e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.285878535769e+09 lambda=7.8125000000000004e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.068045470276e+08 lambda=3.9062500000000002e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.988290932539e+07 lambda=1.9531250000000001e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.001404304764e+06 lambda=9.7656250000000005e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.962234585736e+05 lambda=4.8828125000000003e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.648190078115e+04 lambda=2.4414062500000001e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.098288624714e+03 lambda=1.2207031250000001e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.025132922751e+03 lambda=6.1035156250000003e-06 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.536770142392e+02 lambda=3.0517578125000002e-06 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.529553964021e+02 lambda=6.6615844706846272e-07 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.293970371303e+02 lambda=6.6615844706846277e-08 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291658631829e+02 lambda=6.6615844706846284e-09 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635430890e+02 lambda=6.6615844706846284e-10 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635199508e+02 lambda=6.6615844706846284e-11 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635197268e+02 lambda=6.6615844706846284e-12 > > > > Line search: Cubically determined step, current gnorm 1.291635197253e+02 lambda=1.2496728806533799e-12 > > > > 28 SNES Function norm 1.291635197253e+02 > > > > 0 KSP Residual norm 2.124622394867e+06 > > > > 1 KSP Residual norm 2.766225333896e-07 > > > > Line search: gnorm after quadratic fit 5.963587884154e+17 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.454611858824e+16 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.318582340500e+15 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.164902175749e+15 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.456326197371e+14 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.820904039469e+13 lambda=3.1250000000000002e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.277371273495e+12 lambda=1.5625000000000001e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.849819609184e+11 lambda=7.8125000000000004e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.570050545145e+10 lambda=3.9062500000000002e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.482064028328e+09 lambda=1.9531250000000001e-04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.651631635063e+08 lambda=9.7656250000000005e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.188623828904e+07 lambda=4.8828125000000003e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.302868645305e+06 lambda=2.4414062500000001e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.245214424313e+06 lambda=1.2207031250000001e-05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.775004618570e+05 lambda=6.1035156250000003e-06 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.810228834086e+04 lambda=3.0517578125000002e-06 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.148910945566e+03 lambda=1.5258789062500001e-06 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.133679879416e+03 lambda=7.6293945312500004e-07 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.382468615011e+02 lambda=3.8146972656250002e-07 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.519773483633e+02 lambda=1.4103864371136453e-07 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.293690599792e+02 lambda=1.4103864371136454e-08 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291655645282e+02 lambda=1.4103864371136455e-09 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635401518e+02 lambda=1.4103864371136456e-10 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635199283e+02 lambda=1.4103864371136456e-11 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635197272e+02 lambda=1.4103864371136456e-12 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635197253e+02 lambda=1.4103864371136457e-13 > > > > Line search: unable to find good step length! After 25 tries > > > > Line search: fnorm=1.2916351972528861e+02, gnorm=1.2916351972529532e+02, ynorm=2.1246218291095798e+06, minlambda=9.9999999999999998e-13, lambda=1.4103864371136457e-13, initial slope=-1.6683210999382733e+04 > > > > 0 SNES Function norm 7.158176401507e+03 > > > > 0 KSP Residual norm 7.545626598553e+02 > > > > 1 KSP Residual norm 2.192822940623e-11 > > > > Line search: gnorm after quadratic fit 6.003975664723e+07 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.501930637484e+06 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.380142516806e+05 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.179837352860e+05 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.656902039419e+04 lambda=6.2500000000000003e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.340091686120e+03 lambda=3.1250000000000002e-03 > > > > Line search: Cubically determined step, current gnorm 7.127478647243e+03 lambda=1.5625000000000001e-03 > > > > 1 SNES Function norm 7.127478647243e+03 > > > > 0 KSP Residual norm 3.139792512249e+01 > > > > 1 KSP Residual norm 5.765552480238e-13 > > > > Line search: gnorm after quadratic fit 7.131728282938e+03 > > > > Line search: Cubically determined step, current gnorm 6.730387269330e+03 lambda=5.0000000000000003e-02 > > > > 2 SNES Function norm 6.730387269330e+03 > > > > 0 KSP Residual norm 2.247436817553e+01 > > > > 1 KSP Residual norm 4.129717651221e-13 > > > > Line search: gnorm after quadratic fit 6.018304311910e+03 > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > 3 SNES Function norm 6.018304311910e+03 > > > > 0 KSP Residual norm 1.605973421081e+01 > > > > 1 KSP Residual norm 3.614891198134e-13 > > > > Line search: gnorm after quadratic fit 5.394599276028e+03 > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > 4 SNES Function norm 5.394599276028e+03 > > > > 0 KSP Residual norm 1.491002227850e+01 > > > > 1 KSP Residual norm 5.905756964447e-13 > > > > Line search: gnorm after quadratic fit 4.845108544722e+03 > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > 5 SNES Function norm 4.845108544722e+03 > > > > 0 KSP Residual norm 1.562997766581e+02 > > > > 1 KSP Residual norm 5.722461855805e-12 > > > > Line search: gnorm after quadratic fit 1.663505509947e+05 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.368547472010e+04 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.067825049920e+03 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.852173464442e+03 lambda=1.2500000000000001e-02 > > > > Line search: Cubically determined step, current gnorm 4.819549937425e+03 lambda=6.2500000000000003e-03 > > > > 6 SNES Function norm 4.819549937425e+03 > > > > 0 KSP Residual norm 1.652787385042e+01 > > > > 1 KSP Residual norm 7.774483442550e-13 > > > > Line search: gnorm after quadratic fit 2.868840270198e+03 > > > > Line search: Quadratically determined step, lambda=3.9586658383856743e-01 > > > > 7 SNES Function norm 2.868840270198e+03 > > > > 0 KSP Residual norm 1.220061851091e+01 > > > > 1 KSP Residual norm 4.785407437718e-13 > > > > Line search: gnorm after quadratic fit 2.616720732407e+03 > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > 8 SNES Function norm 2.616720732407e+03 > > > > 0 KSP Residual norm 2.884722153958e+01 > > > > 1 KSP Residual norm 5.474553921306e-13 > > > > Line search: gnorm after quadratic fit 3.025386805317e+03 > > > > Line search: Cubically determined step, current gnorm 2.572110173067e+03 lambda=5.0000000000000003e-02 > > > > 9 SNES Function norm 2.572110173067e+03 > > > > 0 KSP Residual norm 5.239447686736e+01 > > > > 1 KSP Residual norm 1.006906008399e-12 > > > > Line search: gnorm after quadratic fit 5.237562098046e+03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.722529781980e+03 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm 2.553072891461e+03 lambda=2.5000000000000001e-02 > > > > 10 SNES Function norm 2.553072891461e+03 > > > > 0 KSP Residual norm 6.511316788880e+00 > > > > 1 KSP Residual norm 1.340296659008e-13 > > > > Line search: gnorm after quadratic fit 2.299704119080e+03 > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > 11 SNES Function norm 2.299704119080e+03 > > > > 0 KSP Residual norm 5.268131426587e+00 > > > > 1 KSP Residual norm 1.017563310127e-13 > > > > Line search: Using full step: fnorm 2.299704119080e+03 gnorm 7.642690039388e+02 > > > > 12 SNES Function norm 7.642690039388e+02 > > > > 0 KSP Residual norm 1.467735721574e+01 > > > > 1 KSP Residual norm 1.090242963543e-12 > > > > Line search: gnorm after quadratic fit 1.042766084830e+03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.924803860137e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm 7.581126971182e+02 lambda=1.8508848315139208e-02 > > > > 13 SNES Function norm 7.581126971182e+02 > > > > 0 KSP Residual norm 2.222609581896e+00 > > > > 1 KSP Residual norm 5.661437314341e-14 > > > > Line search: gnorm after quadratic fit 6.235337602260e+02 > > > > Line search: Quadratically determined step, lambda=2.1172883827013136e-01 > > > > 14 SNES Function norm 6.235337602260e+02 > > > > 0 KSP Residual norm 3.080209609798e+00 > > > > 1 KSP Residual norm 6.073476899313e-14 > > > > Line search: gnorm after quadratic fit 5.704745248520e+02 > > > > Line search: Quadratically determined step, lambda=1.0142301129466913e-01 > > > > 15 SNES Function norm 5.704745248520e+02 > > > > 0 KSP Residual norm 5.628316803979e+00 > > > > 1 KSP Residual norm 9.930477041779e-14 > > > > Line search: gnorm after quadratic fit 5.401354794776e+02 > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > 16 SNES Function norm 5.401354794776e+02 > > > > 0 KSP Residual norm 2.052541406719e+01 > > > > 1 KSP Residual norm 4.328836834239e-13 > > > > Line search: gnorm after quadratic fit 1.709850100987e+03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.717966555703e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.414032576976e+02 lambda=8.7805694170804971e-03 > > > > Line search: Cubically determined step, current gnorm 5.391967144330e+02 lambda=3.6341472475199424e-03 > > > > 17 SNES Function norm 5.391967144330e+02 > > > > 0 KSP Residual norm 2.246993769488e+00 > > > > 1 KSP Residual norm 5.078373642913e-14 > > > > Line search: gnorm after quadratic fit 4.939618639951e+02 > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > 18 SNES Function norm 4.939618639951e+02 > > > > 0 KSP Residual norm 2.155867648564e+00 > > > > 1 KSP Residual norm 4.438622106380e-14 > > > > Line search: gnorm after quadratic fit 4.334377322188e+02 > > > > Line search: Quadratically determined step, lambda=1.5092486954829210e-01 > > > > 19 SNES Function norm 4.334377322188e+02 > > > > 0 KSP Residual norm 8.318284791610e+00 > > > > 1 KSP Residual norm 6.910116607023e-13 > > > > Line search: gnorm after quadratic fit 6.148799641401e+02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.502386288041e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm 4.297879862602e+02 lambda=1.9565738732695813e-02 > > > > 20 SNES Function norm 4.297879862602e+02 > > > > 0 KSP Residual norm 7.593855254976e+01 > > > > 1 KSP Residual norm 1.300639045149e-12 > > > > Line search: gnorm after quadratic fit 7.318016560287e+04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.832525429452e+03 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.543595712952e+03 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.752901058720e+02 lambda=1.2500000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.309726315570e+02 lambda=1.2500000000000002e-03 > > > > Line search: Cubically determined step, current gnorm 4.297464967378e+02 lambda=2.0986409143217158e-04 > > > > 21 SNES Function norm 4.297464967378e+02 > > > > 0 KSP Residual norm 8.492609701850e+00 > > > > 1 KSP Residual norm 2.830329105288e-13 > > > > Line search: gnorm after quadratic fit 6.575200413213e+02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.532760802544e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm 4.268212296998e+02 lambda=1.8460064973695799e-02 > > > > 22 SNES Function norm 4.268212296998e+02 > > > > 0 KSP Residual norm 2.527155905469e+00 > > > > 1 KSP Residual norm 2.235724978394e-13 > > > > Line search: gnorm after quadratic fit 3.958132075117e+02 > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > 23 SNES Function norm 3.958132075117e+02 > > > > 0 KSP Residual norm 3.425644398425e+00 > > > > 1 KSP Residual norm 7.166017790799e-14 > > > > Line search: gnorm after quadratic fit 3.803199338641e+02 > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > 24 SNES Function norm 3.803199338641e+02 > > > > 0 KSP Residual norm 3.581435186688e+00 > > > > 1 KSP Residual norm 1.730091027109e-13 > > > > Line search: gnorm after quadratic fit 3.678433353709e+02 > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > 25 SNES Function norm 3.678433353709e+02 > > > > 0 KSP Residual norm 2.817439291614e+00 > > > > 1 KSP Residual norm 8.592333136485e-13 > > > > Line search: gnorm after quadratic fit 3.472671313564e+02 > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > 26 SNES Function norm 3.472671313564e+02 > > > > 0 KSP Residual norm 1.830066839089e+00 > > > > 1 KSP Residual norm 3.248934231575e-14 > > > > Line search: gnorm after quadratic fit 3.195079998571e+02 > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > 27 SNES Function norm 3.195079998571e+02 > > > > 0 KSP Residual norm 3.775823654589e+00 > > > > 1 KSP Residual norm 1.316233059492e-13 > > > > Line search: gnorm after quadratic fit 3.252874639934e+02 > > > > Line search: Cubically determined step, current gnorm 3.125168318399e+02 lambda=5.0000000000000003e-02 > > > > 28 SNES Function norm 3.125168318399e+02 > > > > 0 KSP Residual norm 3.892613775622e+00 > > > > 1 KSP Residual norm 7.093200713216e-11 > > > > Line search: gnorm after quadratic fit 3.137590389484e+02 > > > > Line search: Cubically determined step, current gnorm 3.045559021319e+02 lambda=5.0000000000000003e-02 > > > > 29 SNES Function norm 3.045559021319e+02 > > > > 0 KSP Residual norm 2.364531179390e+00 > > > > 1 KSP Residual norm 1.615423543115e-12 > > > > Line search: gnorm after quadratic fit 2.864449141431e+02 > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > 30 SNES Function norm 2.864449141431e+02 > > > > 0 KSP Residual norm 5.187063704081e+00 > > > > 1 KSP Residual norm 4.254799504045e-13 > > > > Line search: gnorm after quadratic fit 3.171238299438e+02 > > > > Line search: Cubically determined step, current gnorm 2.859321807369e+02 lambda=4.9550691080557742e-02 > > > > 31 SNES Function norm 2.859321807369e+02 > > > > 0 KSP Residual norm 2.400449127985e+01 > > > > 1 KSP Residual norm 5.221032480453e-13 > > > > Line search: gnorm after quadratic fit 1.812538817802e+03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.647888939229e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.905120335847e+02 lambda=7.3371687404129469e-03 > > > > Line search: Cubically determined step, current gnorm 2.857698450683e+02 lambda=1.3231746793531958e-03 > > > > 32 SNES Function norm 2.857698450683e+02 > > > > 0 KSP Residual norm 7.438521293559e+00 > > > > 1 KSP Residual norm 1.293652874831e-12 > > > > Line search: gnorm after quadratic fit 3.600694148787e+02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.932936811991e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm 2.832774969882e+02 lambda=1.8636088141277370e-02 > > > > 33 SNES Function norm 2.832774969882e+02 > > > > 0 KSP Residual norm 2.676138557891e+00 > > > > 1 KSP Residual norm 5.204105674042e-12 > > > > Line search: gnorm after quadratic fit 2.698470565576e+02 > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > 34 SNES Function norm 2.698470565576e+02 > > > > 0 KSP Residual norm 1.009562156863e+01 > > > > 1 KSP Residual norm 3.544140587695e-13 > > > > Line search: gnorm after quadratic fit 5.672695948559e+02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.197216154647e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm 2.694068135292e+02 lambda=1.0762403784106927e-02 > > > > 35 SNES Function norm 2.694068135292e+02 > > > > 0 KSP Residual norm 3.927549314525e+00 > > > > 1 KSP Residual norm 2.619134786598e-13 > > > > Line search: gnorm after quadratic fit 2.646675787349e+02 > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > 36 SNES Function norm 2.646675787349e+02 > > > > 0 KSP Residual norm 3.630219417922e+01 > > > > 1 KSP Residual norm 1.546302717349e-12 > > > > Line search: gnorm after quadratic fit 1.827432666108e+04 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.342968941151e+03 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.008633273369e+02 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.490753494196e+02 lambda=1.2345129233072847e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.682474011960e+02 lambda=3.3291959087019770e-03 > > > > Line search: Cubically determined step, current gnorm 2.646227701989e+02 lambda=4.0529212866107715e-04 > > > > 37 SNES Function norm 2.646227701989e+02 > > > > 0 KSP Residual norm 8.122774697994e+00 > > > > 1 KSP Residual norm 1.316362046092e-13 > > > > Line search: gnorm after quadratic fit 4.731092571363e+02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.030088374328e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm 2.637462652877e+02 lambda=9.1057248517509397e-03 > > > > 38 SNES Function norm 2.637462652877e+02 > > > > 0 KSP Residual norm 2.601520363063e+00 > > > > 1 KSP Residual norm 1.060764270007e-12 > > > > Line search: gnorm after quadratic fit 2.536856446094e+02 > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > 39 SNES Function norm 2.536856446094e+02 > > > > 0 KSP Residual norm 5.447955134327e+01 > > > > 1 KSP Residual norm 2.556989975730e-12 > > > > Line search: gnorm after quadratic fit 9.199250935618e+03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.998238940105e+03 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.227083769291e+02 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.852215674478e+02 lambda=8.5024965111563117e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.537821339347e+02 lambda=8.5024965111563122e-04 > > > > Line search: Cubically determined step, current gnorm 2.536484146652e+02 lambda=2.9594242443314720e-04 > > > > 40 SNES Function norm 2.536484146652e+02 > > > > 0 KSP Residual norm 3.357359266965e+01 > > > > 1 KSP Residual norm 8.485166742752e-11 > > > > Line search: gnorm after quadratic fit 3.327150899857e+03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.660943990394e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.428891921377e+02 lambda=2.2262238648584176e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.550059920785e+02 lambda=3.9120439672600755e-03 > > > > Line search: Cubically determined step, current gnorm 2.535425543202e+02 lambda=8.8078244093807846e-04 > > > > 41 SNES Function norm 2.535425543202e+02 > > > > 0 KSP Residual norm 1.982789391732e+01 > > > > 1 KSP Residual norm 1.156473750758e-11 > > > > Line search: gnorm after quadratic fit 9.648483369708e+02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.023504841042e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.554919970151e+02 lambda=8.7092873850291869e-03 > > > > Line search: Cubically determined step, current gnorm 2.532490636747e+02 lambda=2.4564558988847251e-03 > > > > 42 SNES Function norm 2.532490636747e+02 > > > > 0 KSP Residual norm 1.762994613361e+01 > > > > 1 KSP Residual norm 4.550684860593e-12 > > > > Line search: gnorm after quadratic fit 6.772107527838e+02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.370541870778e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.532869639177e+02 lambda=7.7662700854918328e-03 > > > > Line search: Cubically determined step, current gnorm 2.527651129995e+02 lambda=3.8686733161537824e-03 > > > > 43 SNES Function norm 2.527651129995e+02 > > > > 0 KSP Residual norm 1.559278923951e+01 > > > > 1 KSP Residual norm 1.060470887103e-11 > > > > Line search: gnorm after quadratic fit 7.344361373020e+02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.498001534426e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.530518382567e+02 lambda=7.6730113050967469e-03 > > > > Line search: Cubically determined step, current gnorm 2.523423548732e+02 lambda=3.4156098513217236e-03 > > > > 44 SNES Function norm 2.523423548732e+02 > > > > 0 KSP Residual norm 1.190500639095e+01 > > > > 1 KSP Residual norm 6.311739265577e-12 > > > > Line search: gnorm after quadratic fit 4.875196633557e+02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.933215922947e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm 2.516782376717e+02 lambda=9.8878729665301743e-03 > > > > 45 SNES Function norm 2.516782376717e+02 > > > > 0 KSP Residual norm 1.003632001309e+01 > > > > 1 KSP Residual norm 7.039473047666e-13 > > > > Line search: gnorm after quadratic fit 3.417133560813e+02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.636443273929e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm 2.499729768042e+02 lambda=1.5332495922160540e-02 > > > > 46 SNES Function norm 2.499729768042e+02 > > > > 0 KSP Residual norm 5.252587112411e+01 > > > > 1 KSP Residual norm 2.072629114336e-12 > > > > Line search: gnorm after quadratic fit 7.891803681498e+03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.819076698717e+03 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.911876424956e+02 lambda=2.4538865368827514e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.688195882303e+02 lambda=6.5764457912135515e-03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.500076295129e+02 lambda=6.5764457912135523e-04 > > > > Line search: Cubically determined step, current gnorm 2.499390700783e+02 lambda=2.7231956365922875e-04 > > > > 47 SNES Function norm 2.499390700783e+02 > > > > 0 KSP Residual norm 4.007648116930e+01 > > > > 1 KSP Residual norm 5.646654234336e-11 > > > > Line search: gnorm after quadratic fit 6.276152857499e+03 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.418274035925e+03 lambda=5.0000000000000003e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.785345842563e+02 lambda=2.5000000000000001e-02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.665412152699e+02 lambda=8.0607289886479045e-03 > > > > Line search: Cubically determined step, current gnorm 2.499109739904e+02 lambda=8.0607289886479045e-04 > > > > 48 SNES Function norm 2.499109739904e+02 > > > > 0 KSP Residual norm 1.339756751889e+01 > > > > 1 KSP Residual norm 2.559175980945e-13 > > > > Line search: gnorm after quadratic fit 6.052259901869e+02 > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.217431518450e+02 lambda=5.0000000000000003e-02 > > > > Line search: Cubically determined step, current gnorm 2.496541765916e+02 lambda=7.0239599632283649e-03 > > > > 49 SNES Function norm 2.496541765916e+02 > > > > 0 KSP Residual norm 5.340771873687e+00 > > > > 1 KSP Residual norm 1.207454778077e-13 > > > > Line search: gnorm after quadratic fit 2.760767095070e+02 > > > > Line search: Cubically determined step, current gnorm 2.491630276458e+02 lambda=5.0000000000000003e-02 > > > > 50 SNES Function norm 2.491630276458e+02 > > > > > > > > > > > > On Sat, Aug 26, 2017 at 11:45 PM, Barry Smith wrote: > > > > > > > > > On Aug 26, 2017, at 10:43 PM, zakaryah . wrote: > > > > > > > > > > Hi Barry - many thanks for taking the time to understand my many problems and providing so much help. > > > > > > > > > > The reason I was concerned that I could not alter the linesearch was when I tried to use bt instead of the L-BFGS default, cp, the code crashed with an error like "Could not get Jacobian". Maybe this is an incompatibility like you say, since L-BFGS only uses the initial Jacobian and I never tried setting the scale type. > > > > > > > > > > I took your advice and tried to shrink the problem. First I tried shrinking by a factor 1000 but this converged very quickly with all test data I could provide, including the data which was problematic with the large grid. So I settled for a reduction in size by a factor 125. The grid size is 13,230. This is a decent test case because the solver fails to converge with the options I was using before, and it is small enough that I can run it with the options you suggested (-snes_fd_color -snes_type newtonls -snes_monitor -snes_linesearch_monitor -ksp_monitor -pc_type lu). > > > > > > > > > > The output is 1800 lines long - how shall I share it? > > > > > > > > Just email it, that is small enough for email. > > > > > > > > Barry > > > > > > > > > > > > > > > > > > > > > > > > > > > > > On Sat, Aug 26, 2017 at 7:38 PM, Barry Smith wrote: > > > > > > > > > > > On Aug 26, 2017, at 5:56 PM, zakaryah . wrote: > > > > > > > > > > > > I'm using PETSc's SNES methods to solve PDEs which result from Euler-Lagrange equations for the strain energy of a 3D displacement field. There is an additional term in the Lagrangian which describes external forces which arise from various data sets, and that term contains nonlinearities (field terms higher than linear). The grid has about 1.6e6 elements, and the displacement field has 3 components at each grid element. > > > > > > > > > > > > I'm trying to solve a sequence of successively more complicated equations, and the latest equation is failing to converge on some data sets. In particular, the methods were successful for the infinitesimal bulk strain (compression) energy, as well as the full infinitesimal strain energy (bulk + shear), but I'm now trying to generalize to the finite strain, as certain data sets are known to result from displacement fields for which the infinitesimal strain is a poor approximation. > > > > > > > > > > > > I'm using a DMDA, closely following example 48, and my preferred solver is L-BFGS. > > > > > > > > > > So you are using ? > > > > > > > > > > -snes_type qn -snes_qn_type lbfgs > > > > > > > > > > > > > > > > > I have read the FAQs "Why is Newton's method not converging??" and "Why is my iterative linear solver not converging??"? which have raised a number of questions: > > > > > > > > > > Quasi Newton methods either don't use Jacobians or use only the initial Jacobian (the idea behind quasi-Newton methods is to approximate Jacobian information from previous iterations without having the user compute a Jacobian at each iteration). With PETSc's qn it only uses the Jacobian if you use the option > > > > > > > > > > -snes_qn_scale_type Jacobian > > > > > > > > > > otherwise the Jacobian is never computed or used > > > > > > > > > > > > > > > > > > > > > > Is there documentation for the DMDA/SNES methods somewhere? I don't understand these very well. For example, I am not allocating any matrix for the global Jacobian, and I believe this prevents me from changing the line search. If I'm mistaken I would love to see an example of changing the line search type while using DMDA/SNES. > > > > > > > > > > Whether you provide a Jacobian or not is orthogonal to the line search. > > > > > > > > > > You should be able to change the line search with > > > > > > > > > > -snes_linesearch_type bt or nleqerr or basic or l2 or cp > > > > > > > > > > not all of them may work with qn > > > > > > > > > > > > > > > > > > > > > > I don't know how to interpret the linesearch monitor. Even for problems which are converging properly, the linesearch monitor reports "lssucceed=0" on every iteration. Is this a problem? > > > > > > > > > > It returns a 0 if the line search does not believe it has achieved "sufficient decrease" in the function norm (or possibly some other measure of decrease) you should run -snes_linesearch_monitor also with the option -snes_monitor to see what is happening to the function norm > > > > > > > > > > For qn you can add the option > > > > > > > > > > -snes_qn_monitor > > > > > > > > > > to get more detailed monitoring > > > > > > > > > > > > > > > > > > > > > > I'm also having trouble understanding the methods for troubleshooting. I suspect that I've made an error in the analytical Jacobian, which has a rather large number of non-zero elements, but I have no idea how to use -snes_type test -snes_test_display. The FAQs mention that some troubleshooting tools are more useful for small test problems. How small is small? > > > > > > > > > > Tiny, at most a few dozen rows and columns in the Jacobin. > > > > > > > > > > You should run without the -snes_test_display information, what does it say? Does it indicate the Jacobian or report there is likely a problem? > > > > > > > > > > With DMDA you can also use -snes_fd_color to have PETSc compute the Jacobian for you instead of using your analytical form. If it works with this, but not your Jacobian then your Jacobian is wrong. > > > > > > > > > > > When I try to run the program with -snes_type test -snes_test_display, I get errors like: > > > > > > > > > > > > [0]PETSC ERROR: Argument out of range [0]PETSC ERROR: Local index 1076396032 too large 4979879 (max) at 0 > > > > > > > > > > > > The second size is 1 less than the number of field elements, while the first number seems too large for any aspect of the problem - the Jacobian has at most 59 non-zero columns per row. > > > > > > > > > > > > Because I suspect a possible error in the Jacobian, I ran with -snes_mf_operator -pc_type ksp -ksp_ksp_rtol 1e-12 and observed very similar failure to converge (diverging residual) as with the explicit Jacobian. > > > > > > > > > > What do you get with -ksp_monitor -ksp_ksp_monitor it sounds like the true Jacobian is either very ill-conditioned or your function evaluation is wrong. > > > > > > > > > > > Do I need to set an SNES method which is somehow compatible with the "matrix-free" approach? If I instead use -snes_mf, the problem seems to converge, but horrendously slowly (true residual relative decrease by about 1e-5 per iteration). I suppose this supports my suspicion that the Jacobian is incorrect but doesn't really suggest a solution. > > > > > > > > > > > > Is it possible that the analytical Jacobian is correct, but somehow pathological, which causes the SNES to diverge? > > > > > > > > > > Yes > > > > > > > > > > > Neither the Jacobian nor the function have singularities. > > > > > > > > > > > > Thanks for any help you can provide! > > > > > > > > > > Try really hard to set up a small problem (like just use a very coarse grid) to experiment with as you try to get convergence. Using a big problem for debugging convergence is a recipe for pain. > > > > > > > > > > Also since you have a Jacobian I would start with -snes_fd_color -snes_type ls -snes_monitor -snes_linesearch_monitor -ksp_monitor -pc_type lu (not on a huge problem), what happens? Send the output > > > > > > > > > > Barry > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > From zakaryah at gmail.com Sun Aug 27 18:51:59 2017 From: zakaryah at gmail.com (zakaryah .) Date: Sun, 27 Aug 2017 19:51:59 -0400 Subject: [petsc-users] A number of questions about DMDA with SNES and Quasi-Newton methods In-Reply-To: <06932E72-E8F3-4EA8-889F-A570AD660E32@mcs.anl.gov> References: <020DAED9-AAAD-4741-976B-BB2EF6C79D3F@mcs.anl.gov> <5BF530F6-8D79-47E6-B2C5-B0702FF2AA59@mcs.anl.gov> <7EE84495-4346-4BFB-B9AD-BCAA3C722461@mcs.anl.gov> <08AA1273-062D-4FDD-8709-40AA1FE8AA92@mcs.anl.gov> <06932E72-E8F3-4EA8-889F-A570AD660E32@mcs.anl.gov> Message-ID: OK, I'm with you. Here's my call to DMDACreate: ierr = DMDACreate3d(PETSC_COMM_WORLD, DM_BOUNDARY_NONE, DM_BOUNDARY_NONE, DM_BOUNDARY_NONE, DMDA_STENCIL_BOX, mp->W, mp->H, mp->D,PETSC_DECIDE, PETSC_DECIDE, PETSC_DECIDE, 3, 1, NULL, NULL, NULL, &(mp->PETSc_da));CHKERRQ(ierr); The grid dimensions are mp->W x mp->H x mp->D, and there are three degrees of freedom at each grid location (x, y, z terms of field). In my Jacobian routine, at the row representing grid coordinate ix, iy, iz, and each of the 3 dof, I set values in columns corresponding to ix+/-1, iy+/-1, iz+/-1, but not all 27 such coordinates (the Jacobian is zero at the 8 corners of the cube). The code for the Jacobian is explicit at the boundaries. In other words, the ix-1 terms are only set when ix>0. I'm not sure how the code can be detecting a new non-zero element in the Jacobian that early in the code. As I said before, I do not explicitly allocate or set the Jacobian anywhere, following example 48 which also uses a DMDA. On Sun, Aug 27, 2017 at 7:29 PM, Barry Smith wrote: > > > On Aug 27, 2017, at 6:19 PM, zakaryah . wrote: > > > > Heh, I guess it's at least a sign that the two fd methods agreed. This > takes me back to my earlier question - when I call MatSetOption(jac,MAT_NEW_ > NONZERO_LOCATION_ERR,PETSC_FALSE), what is jac? Do I need to preallocate > it? Do I need to get it from the SNES? Do I need to set that matrix as > the SNES Jacobian? Do I allocate the actual number of non-zero rows, or > the entirety of the stencil? I notice that -snes_test_display reports > values for the entire stencil, even though of the 27 points in the stencil, > only 19 can be non-zero. > > Back up a minute I didn't read your previous email well enough, sorry. > See below > > > > > On Sun, Aug 27, 2017 at 5:51 PM, Barry Smith wrote: > > > > Sorry this a flaw with the current release. Call > > > > MatSetOption(jac,MAT_NEW_NONZERO_LOCATION_ERR,PETSC_FALSE) > > > > before the call to the solver. > > > > > > > On Aug 27, 2017, at 12:54 PM, zakaryah . wrote: > > > > > > Is it suspicious that the KSP converges so quickly? I have no > experience with how the solvers behave on such small grids. > > > > > > Also, I ran the code with -snes_type test on a very small grid (1530 > elements). The simpler version of the PDE ran fine, and showed good > agreement of the matrices. However, the more complicated version crashes > with the following errors: > > > > > > Testing hand-coded Jacobian, if the ratio is > > > > > > O(1.e-8), the hand-coded Jacobian is probably correct. > > > > > > Run with -snes_test_display to show difference > > > > > > of hand-coded and finite difference Jacobian. > > > > > > [0]PETSC ERROR: --------------------- Error Message > -------------------------------------------------------------- > > > > > > [0]PETSC ERROR: Argument out of range > > > > > > [0]PETSC ERROR: Inserting a new nonzero at (7,0) in the matrix > > > > > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/ > documentation/faq.html for trouble shooting. > > > > > > [0]PETSC ERROR: Petsc Release Version 3.7.3, Jul, 24, 2016 > > > > > > [0]PETSC ERROR: #1 MatSetValues_SeqAIJ() line 484 in path>/PETSc/build/petsc-3.7.3/src/mat/impls/aij/seq/aij.c > > > > > > [0]PETSC ERROR: #2 MatSetValues() line 1190 in path>/PETSc/build/petsc-3.7.3/src/mat/interface/matrix.c > > > > > > [0]PETSC ERROR: #3 MatSetValuesLocal() line 2053 in path>/PETSc/build/petsc-3.7.3/src/mat/interface/matrix.c > > > > > > [0]PETSC ERROR: #4 MatSetValuesStencil() line 1447 in path>/PETSc/build/petsc-3.7.3/src/mat/interface/matrix.c > > > > > > Does this indicate a bug in the Jacobian calculation? I don't think I > set values outside of the stencil... > > Yes something is definitely wrong, you are inserting a value in a > location the matrix was not expecting. What are your arguments to > DMDACreate()? For stencil width and stencil type? You can run in the > debugger to see why the stencil value doesn't "fit". > > Barry > > > > > > > > > > > > On Sun, Aug 27, 2017 at 12:14 AM, zakaryah . > wrote: > > > Sure - it was this: > > > > > > mpiexec -n 1 -snes_fd_color -snes_type > newtonls -snes_monitor -snes_linesearch_monitor -ksp_monitor -pc_type lu > > > > > > On Sun, Aug 27, 2017 at 12:11 AM, Barry Smith > wrote: > > > > > > > On Aug 26, 2017, at 10:55 PM, zakaryah . wrote: > > > > > > > > Yes, except I changed "-snes_type ls" to "-snes_type newtonls" > because PETSc complained that ls wasn't a known method. > > > > > > Sorry, my memory is not as good as it used to be; but what other > options did you use? Send the exact command line. > > > > > > > > > Barry > > > ' > > > > > > > > On Sat, Aug 26, 2017 at 11:52 PM, Barry Smith > wrote: > > > > > > > > My exact options did you run with? > > > > > > > > > On Aug 26, 2017, at 10:48 PM, zakaryah . > wrote: > > > > > > > > > > Here's the output, from the data set which does not converge with > l-bfgs: > > > > > > > > > > 0 SNES Function norm 1.370293318432e+04 > > > > > 0 KSP Residual norm 7.457506389218e+02 > > > > > 1 KSP Residual norm 2.244764079994e-10 > > > > > Line search: gnorm after quadratic fit 6.541298279196e+05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 8.963717927372e+04 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.788909416707e+04 lambda=2.5000000000000001e-02 > > > > > Line search: Cubically determined step, current gnorm > 1.340565762719e+04 lambda=1.2500000000000001e-02 > > > > > 1 SNES Function norm 1.340565762719e+04 > > > > > 0 KSP Residual norm 4.096066553372e+02 > > > > > 1 KSP Residual norm 3.313671167444e-11 > > > > > Line search: gnorm after quadratic fit 1.113749573695e+06 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.406390140546e+05 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.126781917443e+04 lambda=2.5000000000000001e-02 > > > > > Line search: Cubically determined step, current gnorm > 1.272988597973e+04 lambda=1.2500000000000001e-02 > > > > > 2 SNES Function norm 1.272988597973e+04 > > > > > 0 KSP Residual norm 8.291344597817e+01 > > > > > 1 KSP Residual norm 7.182258362182e-12 > > > > > Line search: gnorm after quadratic fit 1.121913743889e+04 > > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > > 3 SNES Function norm 1.121913743889e+04 > > > > > 0 KSP Residual norm 6.830535877014e+01 > > > > > 1 KSP Residual norm 3.629826411580e-12 > > > > > Line search: gnorm after quadratic fit 9.966344973786e+03 > > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > > 4 SNES Function norm 9.966344973786e+03 > > > > > 0 KSP Residual norm 5.137691531345e+01 > > > > > 1 KSP Residual norm 1.954502098181e-12 > > > > > Line search: gnorm after quadratic fit 8.905508641232e+03 > > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > > 5 SNES Function norm 8.905508641232e+03 > > > > > 0 KSP Residual norm 4.295019262963e+01 > > > > > 1 KSP Residual norm 1.581527994925e-12 > > > > > Line search: gnorm after quadratic fit 7.599173694189e+03 > > > > > Line search: Quadratically determined step, > lambda=1.4157226463489950e-01 > > > > > 6 SNES Function norm 7.599173694189e+03 > > > > > 0 KSP Residual norm 3.520472291520e+01 > > > > > 1 KSP Residual norm 1.169994130568e-12 > > > > > Line search: gnorm after quadratic fit 6.797214843928e+03 > > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > > 7 SNES Function norm 6.797214843928e+03 > > > > > 0 KSP Residual norm 2.683523206056e+01 > > > > > 1 KSP Residual norm 9.039858014119e-13 > > > > > Line search: gnorm after quadratic fit 6.098038917364e+03 > > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > > 8 SNES Function norm 6.098038917364e+03 > > > > > 0 KSP Residual norm 2.300710560681e+01 > > > > > 1 KSP Residual norm 1.010402303464e-12 > > > > > Line search: gnorm after quadratic fit 5.486151385552e+03 > > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > > 9 SNES Function norm 5.486151385552e+03 > > > > > 0 KSP Residual norm 2.824628827619e+01 > > > > > 1 KSP Residual norm 1.009589866569e-12 > > > > > Line search: gnorm after quadratic fit 4.964991021247e+03 > > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > > 10 SNES Function norm 4.964991021247e+03 > > > > > 0 KSP Residual norm 6.285926028595e+01 > > > > > 1 KSP Residual norm 2.833546214180e-12 > > > > > Line search: gnorm after quadratic fit 2.100041391472e+04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.804051080767e+03 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm > 4.893296169579e+03 lambda=2.5000000000000001e-02 > > > > > 11 SNES Function norm 4.893296169579e+03 > > > > > 0 KSP Residual norm 1.688978282804e+01 > > > > > 1 KSP Residual norm 5.927677470786e-13 > > > > > Line search: gnorm after quadratic fit 4.400894622431e+03 > > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > > 12 SNES Function norm 4.400894622431e+03 > > > > > 0 KSP Residual norm 1.481197699600e+01 > > > > > 1 KSP Residual norm 4.522572128105e-13 > > > > > Line search: Using full step: fnorm 4.400894622431e+03 gnorm > 2.094971849007e+03 > > > > > 13 SNES Function norm 2.094971849007e+03 > > > > > 0 KSP Residual norm 3.514164563318e+00 > > > > > 1 KSP Residual norm 3.022385947499e-13 > > > > > Line search: gnorm after quadratic fit 1.687641025382e+03 > > > > > Line search: Quadratically determined step, > lambda=2.0307116693368590e-01 > > > > > 14 SNES Function norm 1.687641025382e+03 > > > > > 0 KSP Residual norm 2.138591884686e+00 > > > > > 1 KSP Residual norm 4.023500814078e-14 > > > > > Line search: Using full step: fnorm 1.687641025382e+03 gnorm > 1.131934218470e+03 > > > > > 15 SNES Function norm 1.131934218470e+03 > > > > > 0 KSP Residual norm 3.245035110327e+00 > > > > > 1 KSP Residual norm 1.293626215269e-13 > > > > > Line search: Using full step: fnorm 1.131934218470e+03 gnorm > 7.340573607307e+02 > > > > > 16 SNES Function norm 7.340573607307e+02 > > > > > 0 KSP Residual norm 1.957698957904e+00 > > > > > 1 KSP Residual norm 3.444648967078e-13 > > > > > Line search: Using full step: fnorm 7.340573607307e+02 gnorm > 5.024723505168e+02 > > > > > 17 SNES Function norm 5.024723505168e+02 > > > > > 0 KSP Residual norm 2.510538703839e+00 > > > > > 1 KSP Residual norm 8.570440675253e-14 > > > > > Line search: gnorm after quadratic fit 4.548776456608e+02 > > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > > 18 SNES Function norm 4.548776456608e+02 > > > > > 0 KSP Residual norm 6.741705718178e-01 > > > > > 1 KSP Residual norm 1.650556120809e-14 > > > > > Line search: Using full step: fnorm 4.548776456608e+02 gnorm > 1.351189086642e+02 > > > > > 19 SNES Function norm 1.351189086642e+02 > > > > > 0 KSP Residual norm 7.653741241950e+00 > > > > > 1 KSP Residual norm 8.326848236950e-14 > > > > > Line search: gnorm after quadratic fit 4.215455105006e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.889750369356e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.358691836999e+02 lambda=1.0303015930243279e-02 > > > > > Line search: Cubically determined step, current gnorm > 1.348911963390e+02 lambda=3.5279526770504110e-03 > > > > > 20 SNES Function norm 1.348911963390e+02 > > > > > 0 KSP Residual norm 4.209281176918e+00 > > > > > 1 KSP Residual norm 1.233232881375e-13 > > > > > Line search: gnorm after quadratic fit 1.860023264470e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.413911132196e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm > 1.339597869053e+02 lambda=1.5787957598629023e-02 > > > > > 21 SNES Function norm 1.339597869053e+02 > > > > > 0 KSP Residual norm 1.718484765841e+00 > > > > > 1 KSP Residual norm 6.666016296543e-14 > > > > > Line search: gnorm after quadratic fit 1.326878521472e+02 > > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > > 22 SNES Function norm 1.326878521472e+02 > > > > > 0 KSP Residual norm 1.515373499919e+00 > > > > > 1 KSP Residual norm 2.259154130795e-12 > > > > > Line search: gnorm after quadratic fit 1.226907316391e+02 > > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > > 23 SNES Function norm 1.226907316391e+02 > > > > > 0 KSP Residual norm 1.080252936903e+00 > > > > > 1 KSP Residual norm 1.847020526683e-14 > > > > > Line search: gnorm after quadratic fit 1.163632111851e+02 > > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > > 24 SNES Function norm 1.163632111851e+02 > > > > > 0 KSP Residual norm 2.491746958382e+00 > > > > > 1 KSP Residual norm 6.389134193637e-14 > > > > > Line search: gnorm after quadratic fit 1.345487153563e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.169738363622e+02 lambda=4.4108900954515480e-02 > > > > > Line search: Cubically determined step, current gnorm > 1.152177638108e+02 lambda=1.9997442889243631e-02 > > > > > 25 SNES Function norm 1.152177638108e+02 > > > > > 0 KSP Residual norm 5.364385501004e+00 > > > > > 1 KSP Residual norm 8.457149562463e-14 > > > > > Line search: gnorm after quadratic fit 2.722095758964e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.480946353374e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm > 1.150680255994e+02 lambda=6.3560128131639167e-03 > > > > > 26 SNES Function norm 1.150680255994e+02 > > > > > 0 KSP Residual norm 4.302025268263e+00 > > > > > 1 KSP Residual norm 1.017526937941e-13 > > > > > Line search: gnorm after quadratic fit 1.956300983573e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.318600522939e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm > 1.147123505014e+02 lambda=7.6060788653548803e-03 > > > > > 27 SNES Function norm 1.147123505014e+02 > > > > > 0 KSP Residual norm 6.195463111324e+00 > > > > > 1 KSP Residual norm 1.235283250361e-13 > > > > > Line search: gnorm after quadratic fit 3.324821547049e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.612593208504e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.147389525772e+02 lambda=6.1750939181374294e-03 > > > > > Line search: Cubically determined step, current gnorm > 1.145411432123e+02 lambda=3.0078592586792975e-03 > > > > > 28 SNES Function norm 1.145411432123e+02 > > > > > 0 KSP Residual norm 1.454704250187e+01 > > > > > 1 KSP Residual norm 2.368485174123e-13 > > > > > Line search: gnorm after quadratic fit 1.216293873116e+03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.796524621727e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.359314163651e+02 lambda=1.4867675803955788e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.146009802557e+02 lambda=1.4867675803955788e-03 > > > > > Line search: Cubically determined step, current gnorm > 1.145096815033e+02 lambda=5.5250912472932839e-04 > > > > > 29 SNES Function norm 1.145096815033e+02 > > > > > 0 KSP Residual norm 3.430451345093e+01 > > > > > 1 KSP Residual norm 1.069396165938e-12 > > > > > Line search: gnorm after quadratic fit 1.161329407098e+04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.260690718050e+03 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.696806489042e+02 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.960149915648e+02 lambda=1.1276129246469476e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.158113641658e+02 lambda=1.5873910451430554e-03 > > > > > Line search: Cubically determined step, current gnorm > 1.145062232916e+02 lambda=1.5873910451430555e-04 > > > > > 30 SNES Function norm 1.145062232916e+02 > > > > > 0 KSP Residual norm 2.662578971526e+01 > > > > > 1 KSP Residual norm 5.464011789728e-13 > > > > > Line search: gnorm after quadratic fit 4.375119254490e+03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.038018103928e+03 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.169328002874e+02 lambda=2.3789161387159519e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.262835432714e+02 lambda=5.9737415571960795e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.145626045197e+02 lambda=5.9737415571960802e-04 > > > > > Line search: Cubically determined step, current gnorm > 1.144968604079e+02 lambda=1.6421773527706333e-04 > > > > > 31 SNES Function norm 1.144968604079e+02 > > > > > 0 KSP Residual norm 6.322033697338e+01 > > > > > 1 KSP Residual norm 1.507157991448e-12 > > > > > Line search: gnorm after quadratic fit 5.809243699277e+04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 9.460487584142e+03 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.893183483197e+03 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.960337007072e+02 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.771527792790e+02 lambda=5.3912931685137378e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.150137639707e+02 lambda=5.3912931685137376e-04 > > > > > Line search: Cubically determined step, current gnorm > 1.144964484571e+02 lambda=5.3912931685137380e-05 > > > > > 32 SNES Function norm 1.144964484571e+02 > > > > > 0 KSP Residual norm 3.859510930996e+01 > > > > > 1 KSP Residual norm 8.069118044382e-13 > > > > > Line search: gnorm after quadratic fit 1.106329930525e+04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.155884463041e+03 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.933963819094e+02 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.849629797377e+02 lambda=9.7744286136270241e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.150857687050e+02 lambda=9.7744286136270254e-04 > > > > > Line search: Cubically determined step, current gnorm > 1.144922906340e+02 lambda=9.7744286136270254e-05 > > > > > 33 SNES Function norm 1.144922906340e+02 > > > > > 0 KSP Residual norm 4.952038022394e+01 > > > > > 1 KSP Residual norm 7.460263245424e-13 > > > > > Line search: gnorm after quadratic fit 3.005091127220e+04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.229308416025e+03 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.138600794682e+03 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.390856262238e+02 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.394997214983e+02 lambda=4.4582997750629580e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.146836358799e+02 lambda=4.4582997750629581e-04 > > > > > Line search: Cubically determined step, current gnorm > 1.144895966587e+02 lambda=4.7644082443915877e-05 > > > > > 34 SNES Function norm 1.144895966587e+02 > > > > > 0 KSP Residual norm 1.146914786457e+02 > > > > > 1 KSP Residual norm 4.791627042400e-12 > > > > > Line search: gnorm after quadratic fit 2.601294145944e+05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.324148513778e+04 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.247478406023e+03 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.200340900661e+03 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.696223112300e+02 lambda=6.1514413845115794e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.342365431983e+02 lambda=1.7502929694284564e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.146686063035e+02 lambda=1.7502929694284566e-04 > > > > > Line search: Cubically determined step, current gnorm > 1.144895868489e+02 lambda=1.7502929694284566e-05 > > > > > 35 SNES Function norm 1.144895868489e+02 > > > > > 0 KSP Residual norm 6.311017209658e+01 > > > > > 1 KSP Residual norm 8.384445939117e-13 > > > > > Line search: gnorm after quadratic fit 5.781533400572e+04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 9.419557746031e+03 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.886081770030e+03 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.945810143740e+02 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.767820854837e+02 lambda=5.3859001959289735e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.150034040559e+02 lambda=5.3859001959289732e-04 > > > > > Line search: Cubically determined step, current gnorm > 1.144891501665e+02 lambda=5.3859001959289732e-05 > > > > > 36 SNES Function norm 1.144891501665e+02 > > > > > 0 KSP Residual norm 3.880748384332e+01 > > > > > 1 KSP Residual norm 6.400339290453e-13 > > > > > Line search: gnorm after quadratic fit 1.122504184426e+04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.180728237366e+03 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.987870621566e+02 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.863711604331e+02 lambda=9.8150771384688824e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.150916783781e+02 lambda=9.8150771384688824e-04 > > > > > Line search: Cubically determined step, current gnorm > 1.144850837411e+02 lambda=9.8150771384688832e-05 > > > > > 37 SNES Function norm 1.144850837411e+02 > > > > > 0 KSP Residual norm 4.811537498557e+01 > > > > > 1 KSP Residual norm 9.738167670242e-13 > > > > > Line search: gnorm after quadratic fit 2.784098355218e+04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.885118868254e+03 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.074843354348e+03 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.255202820836e+02 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.365202996130e+02 lambda=4.3204204582016374e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.146504919412e+02 lambda=4.3204204582016374e-04 > > > > > Line search: Cubically determined step, current gnorm > 1.144822306241e+02 lambda=5.0376546850227848e-05 > > > > > 38 SNES Function norm 1.144822306241e+02 > > > > > 0 KSP Residual norm 1.120914002482e+02 > > > > > 1 KSP Residual norm 5.452125292284e-12 > > > > > Line search: gnorm after quadratic fit 2.427186680567e+05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.112196656857e+04 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.967397366072e+03 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.149551659770e+03 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.529630886791e+02 lambda=6.0885216927030559e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.315267519231e+02 lambda=1.6656233536183130e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.146353659250e+02 lambda=1.6656233536183130e-04 > > > > > Line search: Cubically determined step, current gnorm > 1.144820487391e+02 lambda=1.6656233536183130e-05 > > > > > 39 SNES Function norm 1.144820487391e+02 > > > > > 0 KSP Residual norm 7.182416170980e+01 > > > > > 1 KSP Residual norm 1.292147133333e-12 > > > > > Line search: gnorm after quadratic fit 8.255331293322e+04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.302939895170e+04 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.501228089911e+03 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.185010378583e+02 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.088179821424e+02 lambda=5.7489510178867142e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.168272901121e+02 lambda=9.7452649444612811e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.144951972300e+02 lambda=9.7452649444612822e-05 > > > > > Line search: Cubically determined step, current gnorm > 1.144807676687e+02 lambda=2.2399506502463798e-05 > > > > > 40 SNES Function norm 1.144807676687e+02 > > > > > 0 KSP Residual norm 1.728679810285e+02 > > > > > 1 KSP Residual norm 3.878068639716e-12 > > > > > Line search: gnorm after quadratic fit 9.011020578535e+05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.111818830011e+05 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.504789858103e+04 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.754312133162e+03 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 7.212492111975e+02 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.199969180537e+02 lambda=2.6424184504193135e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.154794639440e+02 lambda=2.6424184504193136e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.144880673342e+02 lambda=2.6424184504193136e-05 > > > > > Line search: Cubically determined step, current gnorm > 1.144805461570e+02 lambda=3.8712107591125690e-06 > > > > > 41 SNES Function norm 1.144805461570e+02 > > > > > 0 KSP Residual norm 4.162780846202e+02 > > > > > 1 KSP Residual norm 1.732341544934e-11 > > > > > Line search: gnorm after quadratic fit 1.355673864369e+07 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.747523002884e+06 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.342205048417e+05 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.425635699680e+04 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.882150659178e+03 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.259664786336e+03 lambda=3.1250000000000002e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.653670676209e+02 lambda=1.5625000000000001e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.453655830144e+02 lambda=5.8237455565260388e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.147659525018e+02 lambda=5.8237455565260393e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.144827915995e+02 lambda=5.8237455565260400e-06 > > > > > Line search: Cubically determined step, current gnorm > 1.144805080017e+02 lambda=6.6689295146509104e-07 > > > > > 42 SNES Function norm 1.144805080017e+02 > > > > > 0 KSP Residual norm 1.004135512581e+03 > > > > > 1 KSP Residual norm 3.867626041000e-09 > > > > > Line search: gnorm after quadratic fit 1.832578994882e+08 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.269698278878e+07 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.792476589915e+06 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.420660371083e+05 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.321686926168e+04 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.548358078234e+03 lambda=3.1250000000000002e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.429504802276e+03 lambda=1.5625000000000001e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.317723385004e+02 lambda=7.8125000000000004e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.460079723095e+02 lambda=2.5078917343692407e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.147908977725e+02 lambda=2.5078917343692408e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.144833604238e+02 lambda=2.5078917343692412e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.144805106824e+02 lambda=2.5078917343692411e-07 > > > > > Line search: Cubically determined step, current gnorm > 1.144805014337e+02 lambda=1.1468707119027746e-07 > > > > > 43 SNES Function norm 1.144805014337e+02 > > > > > 0 KSP Residual norm 2.418614573592e+03 > > > > > 1 KSP Residual norm 6.085078742847e-10 > > > > > Line search: gnorm after quadratic fit 2.598476259775e+09 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.262759415873e+08 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.116845970403e+07 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.250465130250e+06 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.863493884574e+05 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 9.501468163771e+04 lambda=3.1250000000000002e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.482658980483e+04 lambda=1.5625000000000001e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.802395557883e+03 lambda=7.8125000000000004e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.788149582374e+02 lambda=3.9062500000000002e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.248828337038e+02 lambda=1.8333058767960295e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.186285836222e+02 lambda=3.7550993478654105e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.145209710139e+02 lambda=3.7550993478654107e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.144808670668e+02 lambda=3.7550993478654111e-07 > > > > > Line search: Cubically determined step, current gnorm > 1.144805012252e+02 lambda=3.7550993478654114e-08 > > > > > 44 SNES Function norm 1.144805012252e+02 > > > > > 0 KSP Residual norm 1.432476672735e+03 > > > > > 1 KSP Residual norm 7.850524783892e-11 > > > > > Line search: gnorm after quadratic fit 5.336191593632e+08 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.625576866625e+07 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 8.181408387845e+06 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.003310644422e+06 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.236384273292e+05 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.658430638069e+04 lambda=3.1250000000000002e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.977463068161e+03 lambda=1.5625000000000001e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 7.674238499253e+02 lambda=7.8125000000000004e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.333616820791e+02 lambda=3.3764776729281175e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.161349153752e+02 lambda=4.0497161764116874e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.144966925969e+02 lambda=4.0497161764116874e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.144806214839e+02 lambda=4.0497161764116878e-07 > > > > > Line search: Cubically determined step, current gnorm > 1.144804979966e+02 lambda=5.6339112427782378e-08 > > > > > 45 SNES Function norm 1.144804979966e+02 > > > > > 0 KSP Residual norm 3.453401579761e+03 > > > > > 1 KSP Residual norm 4.197968028126e-09 > > > > > Line search: gnorm after quadratic fit 7.554006183767e+09 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 9.471974940372e+08 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.191613865049e+08 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.509784334249e+07 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.943752478560e+06 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.597601716755e+05 lambda=3.1250000000000002e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.775572331075e+04 lambda=1.5625000000000001e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.418045407608e+03 lambda=7.8125000000000004e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.357066758731e+03 lambda=3.9062500000000002e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.859267839080e+02 lambda=1.9531250000000001e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.501494912160e+02 lambda=7.5160826909319168e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.148144926477e+02 lambda=7.5160826909319171e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.144837498478e+02 lambda=7.5160826909319179e-07 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.144805227746e+02 lambda=7.5160826909319182e-08 > > > > > Line search: Cubically determined step, current gnorm > 1.144804974438e+02 lambda=9.6864021663644795e-09 > > > > > 46 SNES Function norm 1.144804974438e+02 > > > > > 0 KSP Residual norm 8.345139428850e+03 > > > > > 1 KSP Residual norm 1.027819754739e-09 > > > > > Line search: gnorm after quadratic fit 1.061319903906e+11 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.325012985379e+10 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.652236226640e+09 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.055533971630e+08 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.546607716763e+07 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.134442858835e+06 lambda=3.1250000000000002e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.839168570687e+05 lambda=1.5625000000000001e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.830568178626e+04 lambda=7.8125000000000004e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 7.201776786081e+03 lambda=3.9062500000000002e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.540520468013e+03 lambda=1.9531250000000001e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.573504890506e+02 lambda=9.7656250000000005e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.516203908013e+02 lambda=3.2703670177372021e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.148480075676e+02 lambda=3.2703670177372022e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.144841475328e+02 lambda=3.2703670177372023e-07 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.144805305720e+02 lambda=3.2703670177372021e-08 > > > > > Line search: Cubically determined step, current gnorm > 1.144804974367e+02 lambda=3.2703670177372025e-09 > > > > > 47 SNES Function norm 1.144804974367e+02 > > > > > 0 KSP Residual norm 4.668983500382e+03 > > > > > 1 KSP Residual norm 1.398997665317e-09 > > > > > Line search: gnorm after quadratic fit 1.865309565532e+10 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.336975299727e+09 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.934905088739e+08 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.704520478641e+07 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.728477809448e+06 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.193001670096e+05 lambda=3.1250000000000002e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 8.610673238239e+04 lambda=1.5625000000000001e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.354711683605e+04 lambda=7.8125000000000004e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.589557246433e+03 lambda=3.9062500000000002e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.367851970709e+02 lambda=1.9531250000000001e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.136930269795e+02 lambda=9.0316845802227864e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.172186635069e+02 lambda=1.5831613287181393e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.145074017254e+02 lambda=1.5831613287181394e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.144807499816e+02 lambda=1.5831613287181396e-07 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.144804983345e+02 lambda=1.5831613287181397e-08 > > > > > Line search: Cubically determined step, current gnorm > 1.144804971346e+02 lambda=5.2932921109871310e-09 > > > > > 48 SNES Function norm 1.144804971346e+02 > > > > > 0 KSP Residual norm 1.132678078317e+04 > > > > > 1 KSP Residual norm 2.477518733314e-10 > > > > > Line search: gnorm after quadratic fit 2.654659022365e+11 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.315296223725e+10 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.136635677074e+09 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.152507060235e+08 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.397060094478e+07 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 7.898362012287e+06 lambda=3.1250000000000002e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 9.685179520906e+05 lambda=1.5625000000000001e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.194040779842e+05 lambda=7.8125000000000004e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.606415730227e+04 lambda=3.9062500000000002e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.902698091972e+03 lambda=1.9531250000000001e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 7.521549384652e+02 lambda=9.7656250000000005e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.288999778994e+02 lambda=4.1899746703195281e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.157880829786e+02 lambda=4.5470218451893824e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.144935741206e+02 lambda=4.5470218451893828e-07 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.144806232638e+02 lambda=4.5470218451893831e-08 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.144804979250e+02 lambda=4.5470218451893835e-09 > > > > > Line search: Cubically determined step, current gnorm > 1.144804970825e+02 lambda=9.0293679903918216e-10 > > > > > 49 SNES Function norm 1.144804970825e+02 > > > > > 0 KSP Residual norm 2.712544829144e+04 > > > > > 1 KSP Residual norm 4.949246309677e-09 > > > > > Line search: gnorm after quadratic fit 3.650846005745e+12 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.565321055911e+11 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.711080201118e+10 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 7.150022242308e+09 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 8.965954117985e+08 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.128096393645e+08 lambda=3.1250000000000002e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.429702091584e+07 lambda=1.5625000000000001e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.841819946536e+06 lambda=7.8125000000000004e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.465032956946e+05 lambda=3.9062500000000002e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.594210253794e+04 lambda=1.9531250000000001e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.141110278944e+03 lambda=9.7656250000000005e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.306952279045e+03 lambda=4.8828125000000003e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.754164864338e+02 lambda=2.4414062500000001e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.476861367158e+02 lambda=9.2451761406722810e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.147929263780e+02 lambda=9.2451761406722810e-07 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.144836022952e+02 lambda=9.2451761406722821e-08 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.144805271860e+02 lambda=9.2451761406722831e-09 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.144804972895e+02 lambda=9.2451761406722839e-10 > > > > > Line search: Cubically determined step, current gnorm > 1.144804970737e+02 lambda=1.5633616333063305e-10 > > > > > 50 SNES Function norm 1.144804970737e+02 > > > > > 0 SNES Function norm 2.308693894796e+03 > > > > > 0 KSP Residual norm 8.981999720532e+00 > > > > > 1 KSP Residual norm 2.363170936183e-13 > > > > > Line search: Using full step: fnorm 2.308693894796e+03 gnorm > 7.571661187318e+02 > > > > > 1 SNES Function norm 7.571661187318e+02 > > > > > 0 KSP Residual norm 2.149614048903e+00 > > > > > 1 KSP Residual norm 9.511247057888e-13 > > > > > Line search: Using full step: fnorm 7.571661187318e+02 gnorm > 4.450081004997e+02 > > > > > 2 SNES Function norm 4.450081004997e+02 > > > > > 0 KSP Residual norm 1.706469075123e+01 > > > > > 1 KSP Residual norm 5.803815175472e-13 > > > > > Line search: gnorm after quadratic fit 1.510518198899e+03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.850796532980e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.515983139755e+02 lambda=2.0602556887689423e-02 > > > > > Line search: Cubically determined step, current gnorm > 4.434800867235e+02 lambda=8.2396279492937211e-03 > > > > > 3 SNES Function norm 4.434800867235e+02 > > > > > 0 KSP Residual norm 3.208587171626e+00 > > > > > 1 KSP Residual norm 1.099072610659e-13 > > > > > Line search: gnorm after quadratic fit 4.080637194736e+02 > > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > > 4 SNES Function norm 4.080637194736e+02 > > > > > 0 KSP Residual norm 8.136557176540e+00 > > > > > 1 KSP Residual norm 8.800137844173e-13 > > > > > Line search: gnorm after quadratic fit 5.261656549654e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.131114070934e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm > 4.031614746044e+02 lambda=2.4674842039461482e-02 > > > > > 5 SNES Function norm 4.031614746044e+02 > > > > > 0 KSP Residual norm 7.609918907567e+00 > > > > > 1 KSP Residual norm 1.613159932655e-13 > > > > > Line search: gnorm after quadratic fit 5.353908064984e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.110480554132e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm > 3.991168240716e+02 lambda=2.3079500036735322e-02 > > > > > 6 SNES Function norm 3.991168240716e+02 > > > > > 0 KSP Residual norm 3.800845472041e+00 > > > > > 1 KSP Residual norm 4.841682188278e-13 > > > > > Line search: gnorm after quadratic fit 3.787886582952e+02 > > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > > 7 SNES Function norm 3.787886582952e+02 > > > > > 0 KSP Residual norm 1.892621919219e+00 > > > > > 1 KSP Residual norm 3.576655371800e-12 > > > > > Line search: gnorm after quadratic fit 3.440181918909e+02 > > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > > 8 SNES Function norm 3.440181918909e+02 > > > > > 0 KSP Residual norm 3.559759789147e+00 > > > > > 1 KSP Residual norm 8.347521826622e-13 > > > > > Line search: gnorm after quadratic fit 3.287993515195e+02 > > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > > 9 SNES Function norm 3.287993515195e+02 > > > > > 0 KSP Residual norm 1.825073540507e+00 > > > > > 1 KSP Residual norm 8.352745008123e-14 > > > > > Line search: Using full step: fnorm 3.287993515195e+02 gnorm > 2.710650507416e+02 > > > > > 10 SNES Function norm 2.710650507416e+02 > > > > > 0 KSP Residual norm 7.568432945608e-01 > > > > > 1 KSP Residual norm 2.780715252274e-14 > > > > > Line search: Using full step: fnorm 2.710650507416e+02 gnorm > 1.513359047342e+02 > > > > > 11 SNES Function norm 1.513359047342e+02 > > > > > 0 KSP Residual norm 9.387460484575e+00 > > > > > 1 KSP Residual norm 7.091233040676e-13 > > > > > Line search: gnorm after quadratic fit 3.998857979851e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.060972049714e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm > 1.512140169420e+02 lambda=5.4338709720680610e-03 > > > > > 12 SNES Function norm 1.512140169420e+02 > > > > > 0 KSP Residual norm 4.399424360499e+00 > > > > > 1 KSP Residual norm 1.614362118182e-13 > > > > > Line search: gnorm after quadratic fit 1.913552832643e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.559719302467e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm > 1.499985374733e+02 lambda=1.7102027220313589e-02 > > > > > 13 SNES Function norm 1.499985374733e+02 > > > > > 0 KSP Residual norm 3.740397849742e+00 > > > > > 1 KSP Residual norm 8.986775577006e-13 > > > > > Line search: gnorm after quadratic fit 1.764118876632e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.522381536119e+02 lambda=4.8196830215713270e-02 > > > > > Line search: Cubically determined step, current gnorm > 1.486175880390e+02 lambda=1.8881300948189364e-02 > > > > > 14 SNES Function norm 1.486175880390e+02 > > > > > 0 KSP Residual norm 6.067973818528e+00 > > > > > 1 KSP Residual norm 4.527845229549e-13 > > > > > Line search: gnorm after quadratic fit 2.514021299115e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.679972156573e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm > 1.481015724304e+02 lambda=9.0116621678703428e-03 > > > > > 15 SNES Function norm 1.481015724304e+02 > > > > > 0 KSP Residual norm 6.108754994263e+00 > > > > > 1 KSP Residual norm 2.557635976440e-13 > > > > > Line search: gnorm after quadratic fit 2.458081150104e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.681837029397e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm > 1.476148340442e+02 lambda=7.9580911933571953e-03 > > > > > 16 SNES Function norm 1.476148340442e+02 > > > > > 0 KSP Residual norm 7.914946163932e+00 > > > > > 1 KSP Residual norm 1.512066885699e-13 > > > > > Line search: gnorm after quadratic fit 3.458938604598e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.883018868359e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm > 1.474286108114e+02 lambda=6.7262521208543979e-03 > > > > > 17 SNES Function norm 1.474286108114e+02 > > > > > 0 KSP Residual norm 5.285449532689e+00 > > > > > 1 KSP Residual norm 6.693733977456e-12 > > > > > Line search: gnorm after quadratic fit 2.170263102661e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.607560548008e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm > 1.467785507822e+02 lambda=9.9244383205188240e-03 > > > > > 18 SNES Function norm 1.467785507822e+02 > > > > > 0 KSP Residual norm 8.124903695635e+00 > > > > > 1 KSP Residual norm 2.322439601127e-11 > > > > > Line search: gnorm after quadratic fit 3.589716592364e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.907315184877e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm > 1.466341888638e+02 lambda=6.5538271222582893e-03 > > > > > 19 SNES Function norm 1.466341888638e+02 > > > > > 0 KSP Residual norm 5.253550718343e+00 > > > > > 1 KSP Residual norm 1.575657996883e-12 > > > > > Line search: gnorm after quadratic fit 2.155795776725e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.598564001687e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm > 1.459869404602e+02 lambda=9.9195822632931301e-03 > > > > > 20 SNES Function norm 1.459869404602e+02 > > > > > 0 KSP Residual norm 8.405987790193e+00 > > > > > 1 KSP Residual norm 2.046159481178e-13 > > > > > Line search: gnorm after quadratic fit 3.767908298426e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.941885062002e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm > 1.458995232755e+02 lambda=6.4359684554015136e-03 > > > > > 21 SNES Function norm 1.458995232755e+02 > > > > > 0 KSP Residual norm 5.036348246593e+00 > > > > > 1 KSP Residual norm 3.645081669075e-13 > > > > > Line search: gnorm after quadratic fit 2.083222977519e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.575737508694e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm > 1.452039802458e+02 lambda=1.0554092389542354e-02 > > > > > 22 SNES Function norm 1.452039802458e+02 > > > > > 0 KSP Residual norm 8.562292355998e+00 > > > > > 1 KSP Residual norm 3.256332645483e-13 > > > > > Line search: gnorm after quadratic fit 3.869470823355e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.959483128249e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm > 1.451523830598e+02 lambda=6.3780526507799607e-03 > > > > > 23 SNES Function norm 1.451523830598e+02 > > > > > 0 KSP Residual norm 4.919667503862e+00 > > > > > 1 KSP Residual norm 4.823931177115e-13 > > > > > Line search: gnorm after quadratic fit 2.042891039525e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.560623102934e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm > 1.444331916523e+02 lambda=1.0890355421223689e-02 > > > > > 24 SNES Function norm 1.444331916523e+02 > > > > > 0 KSP Residual norm 8.727282395369e+00 > > > > > 1 KSP Residual norm 7.090683582186e-13 > > > > > Line search: gnorm after quadratic fit 3.977929422821e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.978556223200e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm > 1.444215965394e+02 lambda=6.3477766966048947e-03 > > > > > 25 SNES Function norm 1.444215965394e+02 > > > > > 0 KSP Residual norm 4.759732971179e+00 > > > > > 1 KSP Residual norm 7.539889498211e-13 > > > > > Line search: gnorm after quadratic fit 1.990589649135e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.542648241555e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm > 1.436629416941e+02 lambda=1.1434720389464151e-02 > > > > > 26 SNES Function norm 1.436629416941e+02 > > > > > 0 KSP Residual norm 8.844861828477e+00 > > > > > 1 KSP Residual norm 4.372001279689e-13 > > > > > Line search: gnorm after quadratic fit 4.055598972133e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.990820671396e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.436827663113e+02 lambda=6.3302081701296859e-03 > > > > > Line search: Cubically determined step, current gnorm > 1.434397789472e+02 lambda=3.1285674619640730e-03 > > > > > 27 SNES Function norm 1.434397789472e+02 > > > > > 0 KSP Residual norm 2.168630760128e+01 > > > > > 1 KSP Residual norm 3.975838928402e-13 > > > > > Line search: gnorm after quadratic fit 1.655681371309e+03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.972331169594e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.804118272840e+02 lambda=1.6710557456633125e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.435928635079e+02 lambda=1.6710557456633126e-03 > > > > > Line search: Cubically determined step, current gnorm > 1.434032742903e+02 lambda=5.1357350159978810e-04 > > > > > 28 SNES Function norm 1.434032742903e+02 > > > > > 0 KSP Residual norm 5.259508821923e+01 > > > > > 1 KSP Residual norm 1.358381204928e-11 > > > > > Line search: gnorm after quadratic fit 1.908330224731e+04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.431279702545e+03 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 8.060945045253e+02 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.791318323447e+02 lambda=1.2124172979783788e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.491140019897e+02 lambda=2.6952165802905347e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.434246250245e+02 lambda=2.6952165802905350e-04 > > > > > Line search: Cubically determined step, current gnorm > 1.433970449422e+02 lambda=8.6980371578986910e-05 > > > > > 29 SNES Function norm 1.433970449422e+02 > > > > > 0 KSP Residual norm 1.326287161615e+02 > > > > > 1 KSP Residual norm 5.692176796134e-12 > > > > > Line search: gnorm after quadratic fit 2.077891749832e+05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.654187989332e+04 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.213029457851e+03 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.001385334742e+03 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.323976827250e+02 lambda=5.9607661619885998e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.489839529892e+02 lambda=1.0476257410701045e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.434396736634e+02 lambda=1.0476257410701046e-04 > > > > > Line search: Cubically determined step, current gnorm > 1.433960671821e+02 lambda=1.3664867646895530e-05 > > > > > 30 SNES Function norm 1.433960671821e+02 > > > > > 0 KSP Residual norm 3.320710360189e+02 > > > > > 1 KSP Residual norm 1.365660123102e-11 > > > > > Line search: gnorm after quadratic fit 3.597335441013e+06 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.714766420450e+05 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.566809766217e+04 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.038660363150e+04 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.026997416957e+03 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.382653551072e+02 lambda=3.1250000000000002e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.071747386385e+02 lambda=1.3384948046761360e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.439693866777e+02 lambda=1.3384948046761360e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.434000505249e+02 lambda=1.3384948046761361e-05 > > > > > Line search: Cubically determined step, current gnorm > 1.433959111179e+02 lambda=2.1771867000079373e-06 > > > > > 31 SNES Function norm 1.433959111179e+02 > > > > > 0 KSP Residual norm 8.385024273664e+02 > > > > > 1 KSP Residual norm 2.688330817732e-11 > > > > > Line search: gnorm after quadratic fit 5.487352481970e+07 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.776642694838e+06 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 8.310551423141e+05 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.023322644608e+05 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.368662233379e+04 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.472194884015e+03 lambda=3.1250000000000002e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.718801059897e+02 lambda=1.5625000000000001e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.274234972424e+02 lambda=6.3064412238487922e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.442194384053e+02 lambda=6.3064412238487925e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.434033578642e+02 lambda=6.3064412238487927e-06 > > > > > Line search: Cubically determined step, current gnorm > 1.433959042208e+02 lambda=6.3064412238487929e-07 > > > > > 32 SNES Function norm 1.433959042208e+02 > > > > > 0 KSP Residual norm 5.310191626867e+02 > > > > > 1 KSP Residual norm 2.270033897601e-10 > > > > > Line search: gnorm after quadratic fit 1.447633783740e+07 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.859761774309e+06 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.472992503503e+05 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.557594026810e+04 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.969012939380e+03 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.269212161982e+03 lambda=3.1250000000000002e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.859005100842e+02 lambda=1.5625000000000001e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.695095262046e+02 lambda=5.4509037994531233e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.436389958907e+02 lambda=5.4509037994531237e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.433976258223e+02 lambda=5.4509037994531242e-06 > > > > > Line search: Cubically determined step, current gnorm > 1.433958431980e+02 lambda=8.5124820362933632e-07 > > > > > 33 SNES Function norm 1.433958431980e+02 > > > > > 0 KSP Residual norm 1.341142541825e+03 > > > > > 1 KSP Residual norm 4.194815344365e-11 > > > > > Line search: gnorm after quadratic fit 2.256410317099e+08 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.797696259877e+07 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.447237377751e+06 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.221898175722e+05 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.260244723327e+04 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 7.539148524881e+03 lambda=3.1250000000000002e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.558034531173e+03 lambda=1.5625000000000001e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.788188892302e+02 lambda=7.8125000000000004e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.753621043454e+02 lambda=2.4427125599600652e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.437122397600e+02 lambda=2.4427125599600654e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.433986985128e+02 lambda=2.4427125599600655e-06 > > > > > Line search: Cubically determined step, current gnorm > 1.433958402293e+02 lambda=2.4427125599600656e-07 > > > > > 34 SNES Function norm 1.433958402293e+02 > > > > > 0 KSP Residual norm 8.620962950418e+02 > > > > > 1 KSP Residual norm 4.517777375659e-11 > > > > > Line search: gnorm after quadratic fit 6.134442313460e+07 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 7.790495969255e+06 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.008365220843e+06 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.364572513478e+05 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.037891335918e+04 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.640571521199e+03 lambda=3.1250000000000002e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 8.472549649319e+02 lambda=1.5625000000000001e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.906041216274e+02 lambda=7.6348458761785112e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.504925859329e+02 lambda=1.7740973415567094e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.434632637071e+02 lambda=1.7740973415567094e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.433962847027e+02 lambda=1.7740973415567095e-06 > > > > > Line search: Cubically determined step, current gnorm > 1.433958170795e+02 lambda=3.2293255704969003e-07 > > > > > 35 SNES Function norm 1.433958170795e+02 > > > > > 0 KSP Residual norm 2.177497039945e+03 > > > > > 1 KSP Residual norm 8.546235181505e-11 > > > > > Line search: gnorm after quadratic fit 9.689178330938e+08 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.204850731541e+08 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.491460480376e+07 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.833699292784e+06 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.246639021599e+05 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.860166571872e+04 lambda=3.1250000000000002e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.484329051490e+03 lambda=1.5625000000000001e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.050411687443e+03 lambda=7.8125000000000004e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.488366972009e+02 lambda=3.7767265396089055e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.508326035050e+02 lambda=7.2725649346261757e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.434696063559e+02 lambda=7.2725649346261764e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.433964618996e+02 lambda=7.2725649346261768e-07 > > > > > Line search: Cubically determined step, current gnorm > 1.433958141405e+02 lambda=7.2725649346261771e-08 > > > > > 36 SNES Function norm 1.433958141405e+02 > > > > > 0 KSP Residual norm 2.164813477994e+03 > > > > > 1 KSP Residual norm 1.148881458292e-10 > > > > > Line search: gnorm after quadratic fit 9.626940870744e+08 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.210459267934e+08 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.531855101756e+07 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.966826097072e+06 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.611808255272e+05 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.746062783262e+04 lambda=3.1250000000000002e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.252259871244e+03 lambda=1.5625000000000001e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.319447372021e+03 lambda=7.8125000000000004e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.963055448218e+02 lambda=3.9062500000000002e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.719034797105e+02 lambda=1.3935000445038475e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.436664111092e+02 lambda=1.3935000445038476e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.433983336239e+02 lambda=1.3935000445038476e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.433958213497e+02 lambda=1.3935000445038476e-07 > > > > > Line search: Cubically determined step, current gnorm > 1.433958104705e+02 lambda=5.1202466521517630e-08 > > > > > 37 SNES Function norm 1.433958104705e+02 > > > > > 0 KSP Residual norm 5.470482746849e+03 > > > > > 1 KSP Residual norm 2.077456833170e-10 > > > > > Line search: gnorm after quadratic fit 1.541335606193e+10 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.922526157954e+09 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.393079394383e+08 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.967573549050e+07 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.657319925168e+06 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.479516204895e+05 lambda=3.1250000000000002e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.573399122917e+04 lambda=1.5625000000000001e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 7.931177424479e+03 lambda=7.8125000000000004e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.619710606187e+03 lambda=3.9062500000000002e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.924551713717e+02 lambda=1.9531250000000001e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.786095404459e+02 lambda=6.2808469554243522e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.437467476469e+02 lambda=6.2808469554243527e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.433992463439e+02 lambda=6.2808469554243527e-07 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.433958367271e+02 lambda=6.2808469554243525e-08 > > > > > Line search: Cubically determined step, current gnorm > 1.433958098948e+02 lambda=8.0208105170108588e-09 > > > > > 38 SNES Function norm 1.433958098948e+02 > > > > > 0 KSP Residual norm 1.380568582849e+04 > > > > > 1 KSP Residual norm 3.830866223513e-10 > > > > > Line search: gnorm after quadratic fit 2.484973518314e+11 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.108953896984e+10 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.893104137528e+09 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.884003910853e+08 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.150765563542e+07 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 7.811161146103e+06 lambda=3.1250000000000002e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.011017986781e+06 lambda=1.5625000000000001e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.368084343451e+05 lambda=7.8125000000000004e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.042876665700e+04 lambda=3.9062500000000002e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.648735196752e+03 lambda=1.9531250000000001e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 8.489051252413e+02 lambda=9.7656250000000005e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.910677756717e+02 lambda=4.7728537787817724e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.505452645186e+02 lambda=1.1099980464343249e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.434658984864e+02 lambda=1.1099980464343249e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.433964956476e+02 lambda=1.1099980464343249e-07 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.433958153212e+02 lambda=1.1099980464343250e-08 > > > > > Line search: Cubically determined step, current gnorm > 1.433958098048e+02 lambda=1.2587012037197021e-09 > > > > > 39 SNES Function norm 1.433958098048e+02 > > > > > 0 KSP Residual norm 3.492284741552e+04 > > > > > 1 KSP Residual norm 2.459788921244e-09 > > > > > Line search: gnorm after quadratic fit 4.017424324975e+12 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.020053801097e+11 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.270768402853e+10 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 7.827801904036e+09 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 9.758550488105e+08 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.213492627852e+08 lambda=3.1250000000000002e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.502191365805e+07 lambda=1.5625000000000001e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.846947104704e+06 lambda=7.8125000000000004e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.262850216093e+05 lambda=3.9062500000000002e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.879926646684e+04 lambda=1.9531250000000001e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.510203332079e+03 lambda=9.7656250000000005e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.055028679619e+03 lambda=4.8828125000000003e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.503903269554e+02 lambda=2.3633949212111800e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.510245991472e+02 lambda=4.5897967908360529e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.434724062782e+02 lambda=4.5897967908360533e-07 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.433965706606e+02 lambda=4.5897967908360533e-08 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.433958168196e+02 lambda=4.5897967908360538e-09 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.433958098155e+02 lambda=4.5897967908360540e-10 > > > > > Line search: Cubically determined step, current gnorm > 1.433958097906e+02 lambda=1.9745369723997599e-10 > > > > > 40 SNES Function norm 1.433958097906e+02 > > > > > 0 KSP Residual norm 8.722495521587e+04 > > > > > 1 KSP Residual norm 3.742695919275e-09 > > > > > Line search: gnorm after quadratic fit 6.262538457180e+13 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 7.829256308992e+12 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 9.789282877890e+11 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.224340679566e+11 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.532137613500e+10 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.919506047737e+09 lambda=3.1250000000000002e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.410488718338e+08 lambda=1.5625000000000001e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.042211373104e+07 lambda=7.8125000000000004e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.881986305609e+06 lambda=3.9062500000000002e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.080857001861e+05 lambda=1.9531250000000001e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 7.054449734307e+04 lambda=9.7656250000000005e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.109051581397e+04 lambda=4.8828125000000003e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.144985497099e+03 lambda=2.4414062500000001e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.617627947761e+02 lambda=1.2207031250000001e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.132828960986e+02 lambda=5.3137869181552773e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.440403409760e+02 lambda=5.3137869181552777e-07 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.434022226216e+02 lambda=5.3137869181552781e-08 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.433958732177e+02 lambda=5.3137869181552781e-09 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.433958103569e+02 lambda=5.3137869181552779e-10 > > > > > Line search: Cubically determined step, current gnorm > 1.433958097894e+02 lambda=5.3137869181552781e-11 > > > > > 41 SNES Function norm 1.433958097894e+02 > > > > > 0 KSP Residual norm 6.453169081212e+04 > > > > > 1 KSP Residual norm 2.762540688686e-09 > > > > > Line search: gnorm after quadratic fit 2.535166112592e+13 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.168366990040e+12 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.958985371462e+11 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.945064622488e+10 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.172244865713e+09 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 7.693002384290e+08 lambda=3.1250000000000002e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 9.562568994785e+07 lambda=1.5625000000000001e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.182957296890e+07 lambda=7.8125000000000004e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.453260254263e+06 lambda=3.9062500000000002e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.781984147743e+05 lambda=1.9531250000000001e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.294934468515e+04 lambda=9.7656250000000005e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.740461720782e+03 lambda=4.8828125000000003e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 9.162621855154e+02 lambda=2.4414062500000001e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.042417294890e+02 lambda=1.1290474210136388e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.458920680477e+02 lambda=1.4201366604660443e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.434208620254e+02 lambda=1.4201366604660444e-07 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.433960586269e+02 lambda=1.4201366604660445e-08 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.433958120934e+02 lambda=1.4201366604660445e-09 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.433958097940e+02 lambda=1.4201366604660446e-10 > > > > > Line search: Cubically determined step, current gnorm > 1.433958097852e+02 lambda=5.7981795207229486e-11 > > > > > 42 SNES Function norm 1.433958097852e+02 > > > > > 0 KSP Residual norm 1.596625793747e+05 > > > > > 1 KSP Residual norm 6.465899717071e-09 > > > > > Line search: gnorm after quadratic fit 3.840699863976e+14 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.801237514773e+13 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.002454410823e+12 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 7.505340831651e+11 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 9.387378188418e+10 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.174857842415e+10 lambda=3.1250000000000002e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.472211181784e+09 lambda=1.5625000000000001e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.849608933788e+08 lambda=7.8125000000000004e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.336592011613e+07 lambda=3.9062500000000002e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.988079805895e+06 lambda=1.9531250000000001e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.930858080425e+05 lambda=9.7656250000000005e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.521190722497e+04 lambda=4.8828125000000003e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 8.872153015323e+03 lambda=2.4414062500000001e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.772337662956e+03 lambda=1.2207031250000001e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.879470852054e+02 lambda=6.1035156250000003e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.942774855488e+02 lambda=2.4957912736226801e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.438719078958e+02 lambda=2.4957912736226800e-07 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.434005516391e+02 lambda=2.4957912736226800e-08 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.433958568732e+02 lambda=2.4957912736226803e-09 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.433958102244e+02 lambda=2.4957912736226804e-10 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.433958097865e+02 lambda=2.4957912736226805e-11 > > > > > Line search: Cubically determined step, current gnorm > 1.433958097846e+02 lambda=9.2900433293108317e-12 > > > > > 43 SNES Function norm 1.433958097846e+02 > > > > > 0 KSP Residual norm 4.230869747157e+05 > > > > > 1 KSP Residual norm 2.238707423027e-08 > > > > > Line search: gnorm after quadratic fit 7.145700515048e+15 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 8.931871281700e+14 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.116420341041e+14 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.395366610168e+13 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.743811756566e+12 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.178776103292e+11 lambda=3.1250000000000002e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.721012032848e+10 lambda=1.5625000000000001e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.395186924428e+09 lambda=7.8125000000000004e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.229125978585e+08 lambda=3.9062500000000002e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.250971135953e+07 lambda=1.9531250000000001e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.483856203094e+06 lambda=9.7656250000000005e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 7.950671355228e+05 lambda=4.8828125000000003e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 9.795408218555e+04 lambda=2.4414062500000001e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.315025696280e+04 lambda=1.2207031250000001e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.395961070555e+03 lambda=6.1035156250000003e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.565070307576e+02 lambda=3.0517578125000002e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.228949713871e+02 lambda=1.2154989071946628e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.441831998014e+02 lambda=1.2154989071946629e-07 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.434037055996e+02 lambda=1.2154989071946630e-08 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.433958886074e+02 lambda=1.2154989071946630e-09 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.433958105564e+02 lambda=1.2154989071946630e-10 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.433958097907e+02 lambda=1.2154989071946631e-11 > > > > > Line search: Cubically determined step, current gnorm > 1.433958097845e+02 lambda=1.3559489351735629e-12 > > > > > 44 SNES Function norm 1.433958097845e+02 > > > > > 0 KSP Residual norm 1.017589039922e+06 > > > > > 1 KSP Residual norm 5.483283808994e-08 > > > > > Line search: gnorm after quadratic fit 9.942386816509e+16 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.242813073279e+16 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.553553149772e+15 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.942033483320e+14 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.427772097758e+13 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.035291372732e+12 lambda=3.1250000000000002e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.795558047824e+11 lambda=1.5625000000000001e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.748073147307e+10 lambda=7.8125000000000004e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.944235240368e+09 lambda=3.9062500000000002e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 7.453550734860e+08 lambda=1.9531250000000001e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 9.377045707707e+07 lambda=9.7656250000000005e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.188119937132e+07 lambda=4.8828125000000003e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.529730353136e+06 lambda=2.4414062500000001e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.044646611329e+05 lambda=1.2207031250000001e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.974477616118e+04 lambda=6.1035156250000003e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.087923877078e+03 lambda=3.0517578125000002e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.112257173311e+03 lambda=1.5258789062500001e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.536190077033e+02 lambda=7.6293945312500004e-07 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.622567424729e+02 lambda=2.4244966960965791e-07 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.435780438142e+02 lambda=2.4244966960965793e-08 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.433976282603e+02 lambda=2.4244966960965796e-09 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.433958279382e+02 lambda=2.4244966960965797e-10 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.433958099632e+02 lambda=2.4244966960965799e-11 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.433958097860e+02 lambda=2.4244966960965801e-12 > > > > > Line search: Cubically determined step, current gnorm > 1.433958097845e+02 lambda=2.4244966960965801e-13 > > > > > 45 SNES Function norm 1.433958097845e+02 > > > > > 0 KSP Residual norm 2.206687220910e+06 > > > > > 1 KSP Residual norm 4.897651438902e-08 > > > > > Line search: gnorm after quadratic fit 1.013883843512e+18 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.267347883019e+17 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.584167551460e+16 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.980166189110e+15 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.475099638694e+14 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.093604443378e+13 lambda=3.1250000000000002e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.866330988164e+12 lambda=1.5625000000000001e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.831230804145e+11 lambda=7.8125000000000004e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.034848618023e+10 lambda=3.9062500000000002e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 7.533173457427e+09 lambda=1.9531250000000001e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 9.390937545910e+08 lambda=9.7656250000000005e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.167706366282e+08 lambda=4.8828125000000003e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.445357932595e+07 lambda=2.4414062500000001e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.776833600920e+06 lambda=1.2207031250000001e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.177171496134e+05 lambda=6.1035156250000003e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.775750596740e+04 lambda=3.0517578125000002e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.374283858049e+03 lambda=1.5258789062500001e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.030949543491e+03 lambda=7.6293945312500004e-07 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.423064811256e+02 lambda=3.6673216108643130e-07 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.499924205417e+02 lambda=6.7541706529544844e-08 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.434620968378e+02 lambda=6.7541706529544851e-09 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.433964732224e+02 lambda=6.7541706529544853e-10 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.433958164087e+02 lambda=6.7541706529544856e-11 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.433958098496e+02 lambda=6.7541706529544860e-12 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.433958097850e+02 lambda=6.7541706529544869e-13 > > > > > Line search: unable to find good step length! After 24 tries > > > > > Line search: fnorm=1.4339580978447020e+02, > gnorm=1.4339580978501337e+02, ynorm=2.2066872446260620e+06, > minlambda=9.9999999999999998e-13, lambda=6.7541706529544869e-13, initial > slope=-2.0562359199040133e+04 > > > > > 0 SNES Function norm 7.494832241120e+03 > > > > > 0 KSP Residual norm 2.096735360816e+01 > > > > > 1 KSP Residual norm 1.310027756820e-12 > > > > > Line search: gnorm after quadratic fit 6.728375857515e+03 > > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > > 1 SNES Function norm 6.728375857515e+03 > > > > > 0 KSP Residual norm 2.051806116405e+01 > > > > > 1 KSP Residual norm 4.624620138831e-13 > > > > > Line search: gnorm after quadratic fit 6.028616261650e+03 > > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > > 2 SNES Function norm 6.028616261650e+03 > > > > > 0 KSP Residual norm 2.416503160016e+01 > > > > > 1 KSP Residual norm 8.456041680630e-13 > > > > > Line search: gnorm after quadratic fit 5.407473517447e+03 > > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > > 3 SNES Function norm 5.407473517447e+03 > > > > > 0 KSP Residual norm 1.429873750399e+01 > > > > > 1 KSP Residual norm 2.956316145819e-13 > > > > > Line search: Using full step: fnorm 5.407473517447e+03 gnorm > 1.894530516076e+03 > > > > > 4 SNES Function norm 1.894530516076e+03 > > > > > 0 KSP Residual norm 2.898580554597e+00 > > > > > 1 KSP Residual norm 6.622560162623e-14 > > > > > Line search: Using full step: fnorm 1.894530516076e+03 gnorm > 1.794029421846e+03 > > > > > 5 SNES Function norm 1.794029421846e+03 > > > > > 0 KSP Residual norm 1.749678611959e+01 > > > > > 1 KSP Residual norm 8.138905825078e-12 > > > > > Line search: gnorm after quadratic fit 1.767361408940e+03 > > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > > 6 SNES Function norm 1.767361408940e+03 > > > > > 0 KSP Residual norm 1.094404109423e+02 > > > > > 1 KSP Residual norm 7.696691527700e-12 > > > > > Line search: gnorm after quadratic fit 3.545750923895e+04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.153479540314e+03 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.205683629874e+03 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.802976525485e+03 lambda=1.2441094586006883e-02 > > > > > Line search: Cubically determined step, current gnorm > 1.765063299263e+03 lambda=4.9240328094708914e-03 > > > > > 7 SNES Function norm 1.765063299263e+03 > > > > > 0 KSP Residual norm 1.778095975189e+01 > > > > > 1 KSP Residual norm 2.814661813934e-12 > > > > > Line search: gnorm after quadratic fit 2.620761680117e+03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.793045753271e+03 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm > 1.740299227935e+03 lambda=2.5000000000000001e-02 > > > > > 8 SNES Function norm 1.740299227935e+03 > > > > > 0 KSP Residual norm 3.284236894535e+02 > > > > > 1 KSP Residual norm 5.172103783952e-10 > > > > > Line search: gnorm after quadratic fit 2.857820523902e+05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.063993491139e+04 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 7.588139591650e+03 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.491163684413e+03 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.802614760566e+03 lambda=5.7977212395253904e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.741444490992e+03 lambda=1.8448315876950813e-03 > > > > > Line search: Cubically determined step, current gnorm > 1.739663656043e+03 lambda=7.7468345598227730e-04 > > > > > 9 SNES Function norm 1.739663656043e+03 > > > > > 0 KSP Residual norm 4.581839103558e+02 > > > > > 1 KSP Residual norm 2.627035885943e-11 > > > > > Line search: gnorm after quadratic fit 8.199478499066e+05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.127270076812e+05 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.816774161281e+04 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.053723877333e+03 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.971814513392e+03 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.755066208174e+03 lambda=2.7232010924558834e-03 > > > > > Line search: Cubically determined step, current gnorm > 1.739559834479e+03 lambda=8.1458417855297680e-04 > > > > > 10 SNES Function norm 1.739559834479e+03 > > > > > 0 KSP Residual norm 1.463056810139e+02 > > > > > 1 KSP Residual norm 5.383584598825e-12 > > > > > Line search: gnorm after quadratic fit 2.885699620595e+04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.847717401708e+03 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.244464170034e+03 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.769157604338e+03 lambda=1.0857209099577540e-02 > > > > > Line search: Cubically determined step, current gnorm > 1.737356225452e+03 lambda=4.0312937622950231e-03 > > > > > 11 SNES Function norm 1.737356225452e+03 > > > > > 0 KSP Residual norm 1.564105677925e+02 > > > > > 1 KSP Residual norm 6.671164745832e-11 > > > > > Line search: gnorm after quadratic fit 3.815800291873e+04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 7.197027796134e+03 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.373151605545e+03 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.783976520867e+03 lambda=1.2093374970461970e-02 > > > > > Line search: Cubically determined step, current gnorm > 1.735737929915e+03 lambda=4.9529698477569920e-03 > > > > > 12 SNES Function norm 1.735737929915e+03 > > > > > 0 KSP Residual norm 5.030757139645e+01 > > > > > 1 KSP Residual norm 1.157542730692e-12 > > > > > Line search: gnorm after quadratic fit 3.004544441458e+03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.850403239750e+03 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm > 1.722893188305e+03 lambda=2.0881992439921702e-02 > > > > > 13 SNES Function norm 1.722893188305e+03 > > > > > 0 KSP Residual norm 7.123428853845e+01 > > > > > 1 KSP Residual norm 8.671726774894e-12 > > > > > Line search: gnorm after quadratic fit 4.361041499279e+03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.032697222107e+03 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.726212330814e+03 lambda=1.9909470348267504e-02 > > > > > Line search: Cubically determined step, current gnorm > 1.714127356920e+03 lambda=9.9547351741337518e-03 > > > > > 14 SNES Function norm 1.714127356920e+03 > > > > > 0 KSP Residual norm 8.304557447257e+00 > > > > > 1 KSP Residual norm 6.268295862688e-13 > > > > > Line search: gnorm after quadratic fit 1.558163002487e+03 > > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > > 15 SNES Function norm 1.558163002487e+03 > > > > > 0 KSP Residual norm 2.820803287164e+00 > > > > > 1 KSP Residual norm 5.477413853752e-13 > > > > > Line search: gnorm after quadratic fit 1.065673478530e+03 > > > > > Line search: Quadratically determined step, > lambda=3.8943438938591052e-01 > > > > > 16 SNES Function norm 1.065673478530e+03 > > > > > 0 KSP Residual norm 2.296739120664e+00 > > > > > 1 KSP Residual norm 6.273731899885e-14 > > > > > Line search: gnorm after quadratic fit 8.964342150621e+02 > > > > > Line search: Quadratically determined step, > lambda=1.8740736900935545e-01 > > > > > 17 SNES Function norm 8.964342150621e+02 > > > > > 0 KSP Residual norm 5.567568505830e+00 > > > > > 1 KSP Residual norm 8.649083600764e-12 > > > > > Line search: gnorm after quadratic fit 8.322514858992e+02 > > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > > 18 SNES Function norm 8.322514858992e+02 > > > > > 0 KSP Residual norm 1.164393577210e+00 > > > > > 1 KSP Residual norm 2.019248309015e-14 > > > > > Line search: Using full step: fnorm 8.322514858992e+02 gnorm > 3.179750274746e+02 > > > > > 19 SNES Function norm 3.179750274746e+02 > > > > > 0 KSP Residual norm 5.339294310641e+00 > > > > > 1 KSP Residual norm 2.070321587238e-13 > > > > > Line search: gnorm after quadratic fit 3.433012316833e+02 > > > > > Line search: Cubically determined step, current gnorm > 3.140305403821e+02 lambda=5.0000000000000003e-02 > > > > > 20 SNES Function norm 3.140305403821e+02 > > > > > 0 KSP Residual norm 1.177016565578e+01 > > > > > 1 KSP Residual norm 2.413027540446e-13 > > > > > Line search: gnorm after quadratic fit 7.377851778409e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.896721016582e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm > 3.136619309181e+02 lambda=9.7219892278716195e-03 > > > > > 21 SNES Function norm 3.136619309181e+02 > > > > > 0 KSP Residual norm 3.973565083977e+00 > > > > > 1 KSP Residual norm 9.726786674410e-14 > > > > > Line search: gnorm after quadratic fit 3.098277326090e+02 > > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > > 22 SNES Function norm 3.098277326090e+02 > > > > > 0 KSP Residual norm 9.389290683519e+00 > > > > > 1 KSP Residual norm 1.651497163724e-13 > > > > > Line search: gnorm after quadratic fit 6.887970540455e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.588146381477e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.099274823603e+02 lambda=1.6890426151283184e-02 > > > > > Line search: Cubically determined step, current gnorm > 3.084890760827e+02 lambda=8.4452130756415920e-03 > > > > > 23 SNES Function norm 3.084890760827e+02 > > > > > 0 KSP Residual norm 2.381130479641e+00 > > > > > 1 KSP Residual norm 4.694489283156e-14 > > > > > Line search: gnorm after quadratic fit 2.872151876535e+02 > > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > > 24 SNES Function norm 2.872151876535e+02 > > > > > 0 KSP Residual norm 2.405498502269e+00 > > > > > 1 KSP Residual norm 3.316846070538e-13 > > > > > Line search: gnorm after quadratic fit 2.686789761232e+02 > > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > > 25 SNES Function norm 2.686789761232e+02 > > > > > 0 KSP Residual norm 1.728772970554e+00 > > > > > 1 KSP Residual norm 4.132974383339e-14 > > > > > Line search: gnorm after quadratic fit 2.365009918229e+02 > > > > > Line search: Quadratically determined step, > lambda=1.7273357529379074e-01 > > > > > 26 SNES Function norm 2.365009918229e+02 > > > > > 0 KSP Residual norm 4.413764759374e+00 > > > > > 1 KSP Residual norm 5.210690816917e-14 > > > > > Line search: gnorm after quadratic fit 2.756730968257e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.372321757171e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm > 2.335020811250e+02 lambda=2.5000000000000001e-02 > > > > > 27 SNES Function norm 2.335020811250e+02 > > > > > 0 KSP Residual norm 1.606246507553e+00 > > > > > 1 KSP Residual norm 3.564847846678e-14 > > > > > Line search: gnorm after quadratic fit 2.078263630653e+02 > > > > > Line search: Quadratically determined step, > lambda=1.5913860995949433e-01 > > > > > 28 SNES Function norm 2.078263630653e+02 > > > > > 0 KSP Residual norm 3.700632954873e+00 > > > > > 1 KSP Residual norm 5.113863400264e-13 > > > > > Line search: gnorm after quadratic fit 2.142503514807e+02 > > > > > Line search: Cubically determined step, current gnorm > 2.021095009118e+02 lambda=5.0000000000000003e-02 > > > > > 29 SNES Function norm 2.021095009118e+02 > > > > > 0 KSP Residual norm 3.056449560135e+00 > > > > > 1 KSP Residual norm 3.207987681334e-14 > > > > > Line search: gnorm after quadratic fit 2.064252530802e+02 > > > > > Line search: Cubically determined step, current gnorm > 1.978069081639e+02 lambda=5.0000000000000003e-02 > > > > > 30 SNES Function norm 1.978069081639e+02 > > > > > 0 KSP Residual norm 2.024695620703e+00 > > > > > 1 KSP Residual norm 5.460360737995e-14 > > > > > Line search: gnorm after quadratic fit 1.839556530796e+02 > > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > > 31 SNES Function norm 1.839556530796e+02 > > > > > 0 KSP Residual norm 1.610676619931e+01 > > > > > 1 KSP Residual norm 6.703552136307e-13 > > > > > Line search: gnorm after quadratic fit 7.186735314913e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.905672430097e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.856766286600e+02 lambda=1.0830798014298563e-02 > > > > > Line search: Cubically determined step, current gnorm > 1.836818937131e+02 lambda=3.3207362501459785e-03 > > > > > 32 SNES Function norm 1.836818937131e+02 > > > > > 0 KSP Residual norm 7.471722173131e+01 > > > > > 1 KSP Residual norm 2.671534648829e-12 > > > > > Line search: gnorm after quadratic fit 9.613379909411e+04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.509491298762e+04 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.808861367705e+03 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.767283758299e+02 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.665421328348e+02 lambda=6.0369453941238101e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.869726717041e+02 lambda=1.4394327006264963e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.836897704575e+02 lambda=1.4394327006264963e-04 > > > > > Line search: Cubically determined step, current gnorm > 1.836767951408e+02 lambda=5.5567420418543164e-05 > > > > > 33 SNES Function norm 1.836767951408e+02 > > > > > 0 KSP Residual norm 2.702367712138e+01 > > > > > 1 KSP Residual norm 2.731656687850e-12 > > > > > Line search: gnorm after quadratic fit 3.331563146098e+03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 8.723694790688e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.941243220944e+02 lambda=2.1443568774664485e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.847231733910e+02 lambda=2.7571330376860012e-03 > > > > > Line search: Cubically determined step, current gnorm > 1.836356729409e+02 lambda=4.7841280418270480e-04 > > > > > 34 SNES Function norm 1.836356729409e+02 > > > > > 0 KSP Residual norm 1.228333177997e+01 > > > > > 1 KSP Residual norm 2.681127387880e-13 > > > > > Line search: gnorm after quadratic fit 6.936329223475e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.749327218775e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.871557327742e+02 lambda=1.4160505301999991e-02 > > > > > Line search: Cubically determined step, current gnorm > 1.833523080682e+02 lambda=3.5196326548579192e-03 > > > > > 35 SNES Function norm 1.833523080682e+02 > > > > > 0 KSP Residual norm 3.531886257396e+02 > > > > > 1 KSP Residual norm 2.364634092895e-11 > > > > > Line search: gnorm after quadratic fit 3.994783047929e+06 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.753715960726e+05 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.516669898185e+04 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.918985942348e+03 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.363599250418e+03 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.344906818752e+02 lambda=3.1250000000000002e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.991088183980e+02 lambda=1.0108094710462592e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.834621681844e+02 lambda=1.0108094710462593e-04 > > > > > Line search: Cubically determined step, current gnorm > 1.833517377324e+02 lambda=1.0108094710462594e-05 > > > > > 36 SNES Function norm 1.833517377324e+02 > > > > > 0 KSP Residual norm 9.005833507118e+01 > > > > > 1 KSP Residual norm 6.116387880629e-12 > > > > > Line search: gnorm after quadratic fit 8.899847103226e+04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.388111536526e+04 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.532652074749e+03 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.864912734009e+02 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.421068789960e+02 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.873498120960e+02 lambda=2.1924025345283278e-03 > > > > > Line search: Cubically determined step, current gnorm > 1.833506987706e+02 lambda=2.1924025345283280e-04 > > > > > 37 SNES Function norm 1.833506987706e+02 > > > > > 0 KSP Residual norm 1.548426525207e+01 > > > > > 1 KSP Residual norm 1.038038773942e-12 > > > > > Line search: gnorm after quadratic fit 6.702848665441e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.789880616078e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.846521504351e+02 lambda=1.0567302644323170e-02 > > > > > Line search: Cubically determined step, current gnorm > 1.830548481815e+02 lambda=3.5274490352771972e-03 > > > > > 38 SNES Function norm 1.830548481815e+02 > > > > > 0 KSP Residual norm 1.523095478807e+01 > > > > > 1 KSP Residual norm 1.963823596119e-12 > > > > > Line search: gnorm after quadratic fit 9.255727478491e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.496757253461e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.863126241242e+02 lambda=9.3143291632966311e-03 > > > > > Line search: Cubically determined step, current gnorm > 1.829091761403e+02 lambda=1.8107234819462800e-03 > > > > > 39 SNES Function norm 1.829091761403e+02 > > > > > 0 KSP Residual norm 1.311320726934e+01 > > > > > 1 KSP Residual norm 9.084170520902e-13 > > > > > Line search: gnorm after quadratic fit 7.488610069188e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.691148243365e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.885558228772e+02 lambda=1.9439894235886539e-02 > > > > > Line search: Cubically determined step, current gnorm > 1.825540619134e+02 lambda=5.4967824488704169e-03 > > > > > 40 SNES Function norm 1.825540619134e+02 > > > > > 0 KSP Residual norm 1.218635557505e+01 > > > > > 1 KSP Residual norm 7.760485728617e-13 > > > > > Line search: gnorm after quadratic fit 6.636453826807e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.880828006022e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.830493790584e+02 lambda=6.6234802648049863e-03 > > > > > Line search: Cubically determined step, current gnorm > 1.823397545268e+02 lambda=2.4308217464828865e-03 > > > > > 41 SNES Function norm 1.823397545268e+02 > > > > > 0 KSP Residual norm 9.456543593865e+00 > > > > > 1 KSP Residual norm 7.046593270309e-13 > > > > > Line search: gnorm after quadratic fit 3.369769163110e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.105230957789e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm > 1.817897533119e+02 lambda=9.1612481372917148e-03 > > > > > 42 SNES Function norm 1.817897533119e+02 > > > > > 0 KSP Residual norm 7.290035145805e+00 > > > > > 1 KSP Residual norm 3.198962158141e-12 > > > > > Line search: gnorm after quadratic fit 2.858311567415e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.965004842981e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm > 1.808845577764e+02 lambda=1.3826421990147811e-02 > > > > > 43 SNES Function norm 1.808845577764e+02 > > > > > 0 KSP Residual norm 7.256785036157e+00 > > > > > 1 KSP Residual norm 9.243179217625e-14 > > > > > Line search: gnorm after quadratic fit 2.534388176390e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.916726818893e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm > 1.797953125543e+02 lambda=1.3677747819164022e-02 > > > > > 44 SNES Function norm 1.797953125543e+02 > > > > > 0 KSP Residual norm 1.716201096352e+01 > > > > > 1 KSP Residual norm 2.701418800808e-13 > > > > > Line search: gnorm after quadratic fit 1.331064301474e+03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.461842246267e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.920668830294e+02 lambda=1.2856504859057132e-02 > > > > > Line search: Cubically determined step, current gnorm > 1.797121460957e+02 lambda=1.4396611381500967e-03 > > > > > 45 SNES Function norm 1.797121460957e+02 > > > > > 0 KSP Residual norm 6.613432967985e+00 > > > > > 1 KSP Residual norm 1.357752977076e-13 > > > > > Line search: gnorm after quadratic fit 2.721288927858e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.939638282615e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm > 1.787985482018e+02 lambda=1.2647907914070569e-02 > > > > > 46 SNES Function norm 1.787985482018e+02 > > > > > 0 KSP Residual norm 1.225736349281e+01 > > > > > 1 KSP Residual norm 3.819378790812e-13 > > > > > Line search: gnorm after quadratic fit 4.548006065036e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.304803559060e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm > 1.787344729174e+02 lambda=8.9002284237256531e-03 > > > > > 47 SNES Function norm 1.787344729174e+02 > > > > > 0 KSP Residual norm 6.302465402340e+00 > > > > > 1 KSP Residual norm 6.980931947122e-14 > > > > > Line search: gnorm after quadratic fit 2.879477700004e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.980806946742e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm > 1.780128006935e+02 lambda=1.0223293444602008e-02 > > > > > 48 SNES Function norm 1.780128006935e+02 > > > > > 0 KSP Residual norm 4.323829277968e+00 > > > > > 1 KSP Residual norm 5.223881369308e-13 > > > > > Line search: gnorm after quadratic fit 1.957928151218e+02 > > > > > Line search: Cubically determined step, current gnorm > 1.768899805640e+02 lambda=5.0000000000000003e-02 > > > > > 49 SNES Function norm 1.768899805640e+02 > > > > > 0 KSP Residual norm 2.249256107033e+00 > > > > > 1 KSP Residual norm 3.624400957270e-14 > > > > > Line search: gnorm after quadratic fit 1.704782114773e+02 > > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > > 50 SNES Function norm 1.704782114773e+02 > > > > > 0 SNES Function norm 3.513783397332e+03 > > > > > 0 KSP Residual norm 1.650214950648e+01 > > > > > 1 KSP Residual norm 3.574269752690e-13 > > > > > Line search: gnorm after quadratic fit 3.155830404050e+03 > > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > > 1 SNES Function norm 3.155830404050e+03 > > > > > 0 KSP Residual norm 1.443734018042e+01 > > > > > 1 KSP Residual norm 3.685565191058e-13 > > > > > Line search: Using full step: fnorm 3.155830404050e+03 gnorm > 8.581212204155e+02 > > > > > 2 SNES Function norm 8.581212204155e+02 > > > > > 0 KSP Residual norm 2.492601775565e+00 > > > > > 1 KSP Residual norm 9.698440210389e-14 > > > > > Line search: Using full step: fnorm 8.581212204155e+02 gnorm > 7.018609898542e+02 > > > > > 3 SNES Function norm 7.018609898542e+02 > > > > > 0 KSP Residual norm 1.740320986421e+00 > > > > > 1 KSP Residual norm 2.868780682435e-14 > > > > > Line search: Using full step: fnorm 7.018609898542e+02 gnorm > 2.135824235887e+02 > > > > > 4 SNES Function norm 2.135824235887e+02 > > > > > 0 KSP Residual norm 1.647413497077e+00 > > > > > 1 KSP Residual norm 2.731226225666e-14 > > > > > Line search: gnorm after quadratic fit 1.936469032649e+02 > > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > > 5 SNES Function norm 1.936469032649e+02 > > > > > 0 KSP Residual norm 1.406615972124e+00 > > > > > 1 KSP Residual norm 3.167179626699e-14 > > > > > Line search: gnorm after quadratic fit 1.755362571467e+02 > > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > > 6 SNES Function norm 1.755362571467e+02 > > > > > 0 KSP Residual norm 1.480681706594e+00 > > > > > 1 KSP Residual norm 2.935210968935e-14 > > > > > Line search: gnorm after quadratic fit 1.597659506616e+02 > > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > > 7 SNES Function norm 1.597659506616e+02 > > > > > 0 KSP Residual norm 4.013154698097e+00 > > > > > 1 KSP Residual norm 1.021628704832e-13 > > > > > Line search: gnorm after quadratic fit 1.728408060966e+02 > > > > > Line search: Cubically determined step, current gnorm > 1.570815760721e+02 lambda=5.0000000000000003e-02 > > > > > 8 SNES Function norm 1.570815760721e+02 > > > > > 0 KSP Residual norm 1.510335662636e+00 > > > > > 1 KSP Residual norm 2.728243244724e-14 > > > > > Line search: gnorm after quadratic fit 1.450162880692e+02 > > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > > 9 SNES Function norm 1.450162880692e+02 > > > > > 0 KSP Residual norm 1.923349271077e+01 > > > > > 1 KSP Residual norm 1.640711956406e-11 > > > > > Line search: gnorm after quadratic fit 1.016537223115e+03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.584263092048e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.490729346583e+02 lambda=9.3725990358703350e-03 > > > > > Line search: Cubically determined step, current gnorm > 1.449349273006e+02 lambda=1.5464889706033082e-03 > > > > > 10 SNES Function norm 1.449349273006e+02 > > > > > 0 KSP Residual norm 1.154999084194e+01 > > > > > 1 KSP Residual norm 1.292167633338e-11 > > > > > Line search: gnorm after quadratic fit 6.060386918705e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.236630526035e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.491201927819e+02 lambda=1.6816056300124185e-02 > > > > > Line search: Cubically determined step, current gnorm > 1.447023047013e+02 lambda=4.1484374564153808e-03 > > > > > 11 SNES Function norm 1.447023047013e+02 > > > > > 0 KSP Residual norm 7.278906180502e+00 > > > > > 1 KSP Residual norm 2.815632651924e-12 > > > > > Line search: gnorm after quadratic fit 2.512278711773e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.624350957814e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm > 1.441656049510e+02 lambda=1.0879389002513012e-02 > > > > > 12 SNES Function norm 1.441656049510e+02 > > > > > 0 KSP Residual norm 4.449836480267e+00 > > > > > 1 KSP Residual norm 3.152365624813e-13 > > > > > Line search: gnorm after quadratic fit 1.749680739878e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.458763435996e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm > 1.425715025152e+02 lambda=2.2766809271842225e-02 > > > > > 13 SNES Function norm 1.425715025152e+02 > > > > > 0 KSP Residual norm 4.218495037726e+00 > > > > > 1 KSP Residual norm 1.398472536142e-12 > > > > > Line search: gnorm after quadratic fit 1.645159536467e+02 > > > > > Line search: Cubically determined step, current gnorm > 1.421991559212e+02 lambda=4.1883769431247941e-02 > > > > > 14 SNES Function norm 1.421991559212e+02 > > > > > 0 KSP Residual norm 1.968853538608e+00 > > > > > 1 KSP Residual norm 7.594023450519e-12 > > > > > Line search: gnorm after quadratic fit 1.350960142124e+02 > > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > > 15 SNES Function norm 1.350960142124e+02 > > > > > 0 KSP Residual norm 3.444721686085e+00 > > > > > 1 KSP Residual norm 5.312609674019e-14 > > > > > Line search: gnorm after quadratic fit 1.472880565107e+02 > > > > > Line search: Cubically determined step, current gnorm > 1.336714620145e+02 lambda=4.1341550820829437e-02 > > > > > 16 SNES Function norm 1.336714620145e+02 > > > > > 0 KSP Residual norm 3.276288899397e+00 > > > > > 1 KSP Residual norm 8.394674946715e-14 > > > > > Line search: gnorm after quadratic fit 1.459274497150e+02 > > > > > Line search: Cubically determined step, current gnorm > 1.327618539486e+02 lambda=5.0000000000000003e-02 > > > > > 17 SNES Function norm 1.327618539486e+02 > > > > > 0 KSP Residual norm 2.630052244303e+00 > > > > > 1 KSP Residual norm 4.351283410507e-14 > > > > > Line search: gnorm after quadratic fit 1.350378060116e+02 > > > > > Line search: Cubically determined step, current gnorm > 1.299403903934e+02 lambda=4.9913529436269283e-02 > > > > > 18 SNES Function norm 1.299403903934e+02 > > > > > 0 KSP Residual norm 6.124953430138e+00 > > > > > 1 KSP Residual norm 2.295381352938e-13 > > > > > Line search: gnorm after quadratic fit 2.275621676963e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.469611730657e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm > 1.294890694898e+02 lambda=1.0071939100661648e-02 > > > > > 19 SNES Function norm 1.294890694898e+02 > > > > > 0 KSP Residual norm 1.036733907011e+01 > > > > > 1 KSP Residual norm 1.800941381283e-13 > > > > > Line search: gnorm after quadratic fit 3.844879463595e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.875071148504e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm > 1.294494430642e+02 lambda=5.0000000000000010e-03 > > > > > 20 SNES Function norm 1.294494430642e+02 > > > > > 0 KSP Residual norm 8.224001595443e+00 > > > > > 1 KSP Residual norm 3.337810156182e-13 > > > > > Line search: gnorm after quadratic fit 3.332325263497e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.682441841234e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.294720538860e+02 lambda=8.5401597581228530e-03 > > > > > Line search: Cubically determined step, current gnorm > 1.291762382985e+02 lambda=4.2555418164960989e-03 > > > > > 21 SNES Function norm 1.291762382985e+02 > > > > > 0 KSP Residual norm 3.920749219860e+01 > > > > > 1 KSP Residual norm 1.610902886435e-12 > > > > > Line search: gnorm after quadratic fit 3.472422440640e+03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.023065712859e+03 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.228184088700e+02 lambda=1.6004598823093592e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.298607525058e+02 lambda=1.6004598823093593e-03 > > > > > Line search: Cubically determined step, current gnorm > 1.291643460998e+02 lambda=1.9319076533745672e-04 > > > > > 22 SNES Function norm 1.291643460998e+02 > > > > > 0 KSP Residual norm 1.520092314848e+02 > > > > > 1 KSP Residual norm 7.089159192434e-11 > > > > > Line search: gnorm after quadratic fit 2.752539686422e+05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.237188995536e+04 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 7.484370498858e+03 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.571039994484e+03 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.280898858362e+02 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.708927009106e+02 lambda=2.6114913411793973e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.294919567784e+02 lambda=2.6114913411793975e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.291645609810e+02 lambda=2.6114913411793977e-05 > > > > > Line search: Cubically determined step, current gnorm > 1.291635530596e+02 lambda=1.2278773895355162e-05 > > > > > 23 SNES Function norm 1.291635530596e+02 > > > > > 0 KSP Residual norm 7.569206058965e+02 > > > > > 1 KSP Residual norm 3.454693729751e-11 > > > > > Line search: gnorm after quadratic fit 2.570888738395e+07 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.064965025187e+06 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.498514098182e+05 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.807487005202e+04 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.233167830543e+03 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.396736912757e+03 lambda=3.1250000000000002e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.547572543330e+02 lambda=1.2623406091699435e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.335889024473e+02 lambda=1.8542137907683829e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.292059042479e+02 lambda=1.8542137907683831e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.291637618568e+02 lambda=1.8542137907683832e-06 > > > > > Line search: Cubically determined step, current gnorm > 1.291635210734e+02 lambda=4.9524172913414387e-07 > > > > > 24 SNES Function norm 1.291635210734e+02 > > > > > 0 KSP Residual norm 3.761913422861e+03 > > > > > 1 KSP Residual norm 6.181718776929e-10 > > > > > Line search: gnorm after quadratic fit 3.342370445037e+09 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.218326646111e+08 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.375128803204e+07 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.980626157021e+06 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 9.407418671219e+05 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.357321025399e+05 lambda=3.1250000000000002e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.188948059047e+04 lambda=1.5625000000000001e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.105117929713e+03 lambda=7.8125000000000004e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 9.331054736818e+02 lambda=3.9062500000000002e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.942479792843e+02 lambda=1.9412500272460620e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.436944624694e+02 lambda=6.4483223307578726e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.292972287211e+02 lambda=6.4483223307578726e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.291647778160e+02 lambda=6.4483223307578730e-07 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.291635261433e+02 lambda=6.4483223307578730e-08 > > > > > Line search: Cubically determined step, current gnorm > 1.291635197798e+02 lambda=2.0042115918485846e-08 > > > > > 25 SNES Function norm 1.291635197798e+02 > > > > > 0 KSP Residual norm 1.874745766083e+04 > > > > > 1 KSP Residual norm 1.476978150334e-09 > > > > > Line search: gnorm after quadratic fit 4.089262111368e+11 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.101717203770e+10 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.352565940292e+09 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 7.879613196620e+08 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 9.698613558125e+07 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.175566265039e+07 lambda=3.1250000000000002e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.382919964952e+06 lambda=1.5625000000000001e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.545431975334e+05 lambda=7.8125000000000004e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.713561369103e+04 lambda=3.9062500000000002e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.031789308419e+03 lambda=1.9531250000000001e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 9.205847020738e+02 lambda=9.7656250000000005e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.957203153158e+02 lambda=2.8132879163728503e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.297923302791e+02 lambda=2.8132879163728504e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.291698100579e+02 lambda=2.8132879163728504e-07 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.291635794525e+02 lambda=2.8132879163728506e-08 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.291635200489e+02 lambda=2.8132879163728508e-09 > > > > > Line search: Cubically determined step, current gnorm > 1.291635197275e+02 lambda=8.0832061492461345e-10 > > > > > 26 SNES Function norm 1.291635197275e+02 > > > > > 0 KSP Residual norm 9.248381077528e+04 > > > > > 1 KSP Residual norm 7.262307068447e-09 > > > > > Line search: gnorm after quadratic fit 4.920647210624e+13 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.153216818065e+12 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 7.697543960375e+11 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 9.637004379805e+10 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.208402653149e+10 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.519988135798e+09 lambda=3.1250000000000002e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.923903214787e+08 lambda=1.5625000000000001e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.465663001976e+07 lambda=7.8125000000000004e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.238603967195e+06 lambda=3.9062500000000002e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.459179143177e+05 lambda=1.9531250000000001e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.676301042792e+04 lambda=9.7656250000000005e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.135808875752e+04 lambda=4.8828125000000003e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.275714918657e+03 lambda=2.4414062500000001e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.719037747616e+02 lambda=1.2207031250000001e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.039826156716e+02 lambda=5.5609199181402721e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.308092967809e+02 lambda=9.1057337296683134e-07 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.291796742824e+02 lambda=9.1057337296683134e-08 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.291636800174e+02 lambda=9.1057337296683134e-09 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.291635212255e+02 lambda=9.1057337296683134e-10 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.291635197320e+02 lambda=9.1057337296683139e-11 > > > > > Line search: Cubically determined step, current gnorm > 1.291635197254e+02 lambda=3.2898162617097329e-11 > > > > > 27 SNES Function norm 1.291635197254e+02 > > > > > 0 KSP Residual norm 4.818745996826e+05 > > > > > 1 KSP Residual norm 3.300979345194e-08 > > > > > Line search: gnorm after quadratic fit 6.957046028867e+15 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 8.695654311477e+14 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.086793500688e+14 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.358083744813e+13 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.696584801696e+12 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.118183549773e+11 lambda=3.1250000000000002e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.641372080976e+10 lambda=1.5625000000000001e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.285878535769e+09 lambda=7.8125000000000004e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.068045470276e+08 lambda=3.9062500000000002e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.988290932539e+07 lambda=1.9531250000000001e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.001404304764e+06 lambda=9.7656250000000005e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.962234585736e+05 lambda=4.8828125000000003e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 7.648190078115e+04 lambda=2.4414062500000001e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 9.098288624714e+03 lambda=1.2207031250000001e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.025132922751e+03 lambda=6.1035156250000003e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.536770142392e+02 lambda=3.0517578125000002e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.529553964021e+02 lambda=6.6615844706846272e-07 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.293970371303e+02 lambda=6.6615844706846277e-08 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.291658631829e+02 lambda=6.6615844706846284e-09 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.291635430890e+02 lambda=6.6615844706846284e-10 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.291635199508e+02 lambda=6.6615844706846284e-11 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.291635197268e+02 lambda=6.6615844706846284e-12 > > > > > Line search: Cubically determined step, current gnorm > 1.291635197253e+02 lambda=1.2496728806533799e-12 > > > > > 28 SNES Function norm 1.291635197253e+02 > > > > > 0 KSP Residual norm 2.124622394867e+06 > > > > > 1 KSP Residual norm 2.766225333896e-07 > > > > > Line search: gnorm after quadratic fit 5.963587884154e+17 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 7.454611858824e+16 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 9.318582340500e+15 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.164902175749e+15 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.456326197371e+14 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.820904039469e+13 lambda=3.1250000000000002e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.277371273495e+12 lambda=1.5625000000000001e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.849819609184e+11 lambda=7.8125000000000004e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.570050545145e+10 lambda=3.9062500000000002e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.482064028328e+09 lambda=1.9531250000000001e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.651631635063e+08 lambda=9.7656250000000005e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 7.188623828904e+07 lambda=4.8828125000000003e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 9.302868645305e+06 lambda=2.4414062500000001e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.245214424313e+06 lambda=1.2207031250000001e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.775004618570e+05 lambda=6.1035156250000003e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.810228834086e+04 lambda=3.0517578125000002e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.148910945566e+03 lambda=1.5258789062500001e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.133679879416e+03 lambda=7.6293945312500004e-07 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.382468615011e+02 lambda=3.8146972656250002e-07 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.519773483633e+02 lambda=1.4103864371136453e-07 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.293690599792e+02 lambda=1.4103864371136454e-08 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.291655645282e+02 lambda=1.4103864371136455e-09 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.291635401518e+02 lambda=1.4103864371136456e-10 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.291635199283e+02 lambda=1.4103864371136456e-11 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.291635197272e+02 lambda=1.4103864371136456e-12 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.291635197253e+02 lambda=1.4103864371136457e-13 > > > > > Line search: unable to find good step length! After 25 tries > > > > > Line search: fnorm=1.2916351972528861e+02, > gnorm=1.2916351972529532e+02, ynorm=2.1246218291095798e+06, > minlambda=9.9999999999999998e-13, lambda=1.4103864371136457e-13, initial > slope=-1.6683210999382733e+04 > > > > > 0 SNES Function norm 7.158176401507e+03 > > > > > 0 KSP Residual norm 7.545626598553e+02 > > > > > 1 KSP Residual norm 2.192822940623e-11 > > > > > Line search: gnorm after quadratic fit 6.003975664723e+07 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 7.501930637484e+06 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 9.380142516806e+05 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.179837352860e+05 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.656902039419e+04 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 7.340091686120e+03 lambda=3.1250000000000002e-03 > > > > > Line search: Cubically determined step, current gnorm > 7.127478647243e+03 lambda=1.5625000000000001e-03 > > > > > 1 SNES Function norm 7.127478647243e+03 > > > > > 0 KSP Residual norm 3.139792512249e+01 > > > > > 1 KSP Residual norm 5.765552480238e-13 > > > > > Line search: gnorm after quadratic fit 7.131728282938e+03 > > > > > Line search: Cubically determined step, current gnorm > 6.730387269330e+03 lambda=5.0000000000000003e-02 > > > > > 2 SNES Function norm 6.730387269330e+03 > > > > > 0 KSP Residual norm 2.247436817553e+01 > > > > > 1 KSP Residual norm 4.129717651221e-13 > > > > > Line search: gnorm after quadratic fit 6.018304311910e+03 > > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > > 3 SNES Function norm 6.018304311910e+03 > > > > > 0 KSP Residual norm 1.605973421081e+01 > > > > > 1 KSP Residual norm 3.614891198134e-13 > > > > > Line search: gnorm after quadratic fit 5.394599276028e+03 > > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > > 4 SNES Function norm 5.394599276028e+03 > > > > > 0 KSP Residual norm 1.491002227850e+01 > > > > > 1 KSP Residual norm 5.905756964447e-13 > > > > > Line search: gnorm after quadratic fit 4.845108544722e+03 > > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > > 5 SNES Function norm 4.845108544722e+03 > > > > > 0 KSP Residual norm 1.562997766581e+02 > > > > > 1 KSP Residual norm 5.722461855805e-12 > > > > > Line search: gnorm after quadratic fit 1.663505509947e+05 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.368547472010e+04 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.067825049920e+03 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.852173464442e+03 lambda=1.2500000000000001e-02 > > > > > Line search: Cubically determined step, current gnorm > 4.819549937425e+03 lambda=6.2500000000000003e-03 > > > > > 6 SNES Function norm 4.819549937425e+03 > > > > > 0 KSP Residual norm 1.652787385042e+01 > > > > > 1 KSP Residual norm 7.774483442550e-13 > > > > > Line search: gnorm after quadratic fit 2.868840270198e+03 > > > > > Line search: Quadratically determined step, > lambda=3.9586658383856743e-01 > > > > > 7 SNES Function norm 2.868840270198e+03 > > > > > 0 KSP Residual norm 1.220061851091e+01 > > > > > 1 KSP Residual norm 4.785407437718e-13 > > > > > Line search: gnorm after quadratic fit 2.616720732407e+03 > > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > > 8 SNES Function norm 2.616720732407e+03 > > > > > 0 KSP Residual norm 2.884722153958e+01 > > > > > 1 KSP Residual norm 5.474553921306e-13 > > > > > Line search: gnorm after quadratic fit 3.025386805317e+03 > > > > > Line search: Cubically determined step, current gnorm > 2.572110173067e+03 lambda=5.0000000000000003e-02 > > > > > 9 SNES Function norm 2.572110173067e+03 > > > > > 0 KSP Residual norm 5.239447686736e+01 > > > > > 1 KSP Residual norm 1.006906008399e-12 > > > > > Line search: gnorm after quadratic fit 5.237562098046e+03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.722529781980e+03 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm > 2.553072891461e+03 lambda=2.5000000000000001e-02 > > > > > 10 SNES Function norm 2.553072891461e+03 > > > > > 0 KSP Residual norm 6.511316788880e+00 > > > > > 1 KSP Residual norm 1.340296659008e-13 > > > > > Line search: gnorm after quadratic fit 2.299704119080e+03 > > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > > 11 SNES Function norm 2.299704119080e+03 > > > > > 0 KSP Residual norm 5.268131426587e+00 > > > > > 1 KSP Residual norm 1.017563310127e-13 > > > > > Line search: Using full step: fnorm 2.299704119080e+03 gnorm > 7.642690039388e+02 > > > > > 12 SNES Function norm 7.642690039388e+02 > > > > > 0 KSP Residual norm 1.467735721574e+01 > > > > > 1 KSP Residual norm 1.090242963543e-12 > > > > > Line search: gnorm after quadratic fit 1.042766084830e+03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 7.924803860137e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm > 7.581126971182e+02 lambda=1.8508848315139208e-02 > > > > > 13 SNES Function norm 7.581126971182e+02 > > > > > 0 KSP Residual norm 2.222609581896e+00 > > > > > 1 KSP Residual norm 5.661437314341e-14 > > > > > Line search: gnorm after quadratic fit 6.235337602260e+02 > > > > > Line search: Quadratically determined step, > lambda=2.1172883827013136e-01 > > > > > 14 SNES Function norm 6.235337602260e+02 > > > > > 0 KSP Residual norm 3.080209609798e+00 > > > > > 1 KSP Residual norm 6.073476899313e-14 > > > > > Line search: gnorm after quadratic fit 5.704745248520e+02 > > > > > Line search: Quadratically determined step, > lambda=1.0142301129466913e-01 > > > > > 15 SNES Function norm 5.704745248520e+02 > > > > > 0 KSP Residual norm 5.628316803979e+00 > > > > > 1 KSP Residual norm 9.930477041779e-14 > > > > > Line search: gnorm after quadratic fit 5.401354794776e+02 > > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > > 16 SNES Function norm 5.401354794776e+02 > > > > > 0 KSP Residual norm 2.052541406719e+01 > > > > > 1 KSP Residual norm 4.328836834239e-13 > > > > > Line search: gnorm after quadratic fit 1.709850100987e+03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 7.717966555703e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.414032576976e+02 lambda=8.7805694170804971e-03 > > > > > Line search: Cubically determined step, current gnorm > 5.391967144330e+02 lambda=3.6341472475199424e-03 > > > > > 17 SNES Function norm 5.391967144330e+02 > > > > > 0 KSP Residual norm 2.246993769488e+00 > > > > > 1 KSP Residual norm 5.078373642913e-14 > > > > > Line search: gnorm after quadratic fit 4.939618639951e+02 > > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > > 18 SNES Function norm 4.939618639951e+02 > > > > > 0 KSP Residual norm 2.155867648564e+00 > > > > > 1 KSP Residual norm 4.438622106380e-14 > > > > > Line search: gnorm after quadratic fit 4.334377322188e+02 > > > > > Line search: Quadratically determined step, > lambda=1.5092486954829210e-01 > > > > > 19 SNES Function norm 4.334377322188e+02 > > > > > 0 KSP Residual norm 8.318284791610e+00 > > > > > 1 KSP Residual norm 6.910116607023e-13 > > > > > Line search: gnorm after quadratic fit 6.148799641401e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.502386288041e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm > 4.297879862602e+02 lambda=1.9565738732695813e-02 > > > > > 20 SNES Function norm 4.297879862602e+02 > > > > > 0 KSP Residual norm 7.593855254976e+01 > > > > > 1 KSP Residual norm 1.300639045149e-12 > > > > > Line search: gnorm after quadratic fit 7.318016560287e+04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 7.832525429452e+03 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.543595712952e+03 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.752901058720e+02 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.309726315570e+02 lambda=1.2500000000000002e-03 > > > > > Line search: Cubically determined step, current gnorm > 4.297464967378e+02 lambda=2.0986409143217158e-04 > > > > > 21 SNES Function norm 4.297464967378e+02 > > > > > 0 KSP Residual norm 8.492609701850e+00 > > > > > 1 KSP Residual norm 2.830329105288e-13 > > > > > Line search: gnorm after quadratic fit 6.575200413213e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.532760802544e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm > 4.268212296998e+02 lambda=1.8460064973695799e-02 > > > > > 22 SNES Function norm 4.268212296998e+02 > > > > > 0 KSP Residual norm 2.527155905469e+00 > > > > > 1 KSP Residual norm 2.235724978394e-13 > > > > > Line search: gnorm after quadratic fit 3.958132075117e+02 > > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > > 23 SNES Function norm 3.958132075117e+02 > > > > > 0 KSP Residual norm 3.425644398425e+00 > > > > > 1 KSP Residual norm 7.166017790799e-14 > > > > > Line search: gnorm after quadratic fit 3.803199338641e+02 > > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > > 24 SNES Function norm 3.803199338641e+02 > > > > > 0 KSP Residual norm 3.581435186688e+00 > > > > > 1 KSP Residual norm 1.730091027109e-13 > > > > > Line search: gnorm after quadratic fit 3.678433353709e+02 > > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > > 25 SNES Function norm 3.678433353709e+02 > > > > > 0 KSP Residual norm 2.817439291614e+00 > > > > > 1 KSP Residual norm 8.592333136485e-13 > > > > > Line search: gnorm after quadratic fit 3.472671313564e+02 > > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > > 26 SNES Function norm 3.472671313564e+02 > > > > > 0 KSP Residual norm 1.830066839089e+00 > > > > > 1 KSP Residual norm 3.248934231575e-14 > > > > > Line search: gnorm after quadratic fit 3.195079998571e+02 > > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > > 27 SNES Function norm 3.195079998571e+02 > > > > > 0 KSP Residual norm 3.775823654589e+00 > > > > > 1 KSP Residual norm 1.316233059492e-13 > > > > > Line search: gnorm after quadratic fit 3.252874639934e+02 > > > > > Line search: Cubically determined step, current gnorm > 3.125168318399e+02 lambda=5.0000000000000003e-02 > > > > > 28 SNES Function norm 3.125168318399e+02 > > > > > 0 KSP Residual norm 3.892613775622e+00 > > > > > 1 KSP Residual norm 7.093200713216e-11 > > > > > Line search: gnorm after quadratic fit 3.137590389484e+02 > > > > > Line search: Cubically determined step, current gnorm > 3.045559021319e+02 lambda=5.0000000000000003e-02 > > > > > 29 SNES Function norm 3.045559021319e+02 > > > > > 0 KSP Residual norm 2.364531179390e+00 > > > > > 1 KSP Residual norm 1.615423543115e-12 > > > > > Line search: gnorm after quadratic fit 2.864449141431e+02 > > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > > 30 SNES Function norm 2.864449141431e+02 > > > > > 0 KSP Residual norm 5.187063704081e+00 > > > > > 1 KSP Residual norm 4.254799504045e-13 > > > > > Line search: gnorm after quadratic fit 3.171238299438e+02 > > > > > Line search: Cubically determined step, current gnorm > 2.859321807369e+02 lambda=4.9550691080557742e-02 > > > > > 31 SNES Function norm 2.859321807369e+02 > > > > > 0 KSP Residual norm 2.400449127985e+01 > > > > > 1 KSP Residual norm 5.221032480453e-13 > > > > > Line search: gnorm after quadratic fit 1.812538817802e+03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.647888939229e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.905120335847e+02 lambda=7.3371687404129469e-03 > > > > > Line search: Cubically determined step, current gnorm > 2.857698450683e+02 lambda=1.3231746793531958e-03 > > > > > 32 SNES Function norm 2.857698450683e+02 > > > > > 0 KSP Residual norm 7.438521293559e+00 > > > > > 1 KSP Residual norm 1.293652874831e-12 > > > > > Line search: gnorm after quadratic fit 3.600694148787e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.932936811991e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm > 2.832774969882e+02 lambda=1.8636088141277370e-02 > > > > > 33 SNES Function norm 2.832774969882e+02 > > > > > 0 KSP Residual norm 2.676138557891e+00 > > > > > 1 KSP Residual norm 5.204105674042e-12 > > > > > Line search: gnorm after quadratic fit 2.698470565576e+02 > > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > > 34 SNES Function norm 2.698470565576e+02 > > > > > 0 KSP Residual norm 1.009562156863e+01 > > > > > 1 KSP Residual norm 3.544140587695e-13 > > > > > Line search: gnorm after quadratic fit 5.672695948559e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.197216154647e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm > 2.694068135292e+02 lambda=1.0762403784106927e-02 > > > > > 35 SNES Function norm 2.694068135292e+02 > > > > > 0 KSP Residual norm 3.927549314525e+00 > > > > > 1 KSP Residual norm 2.619134786598e-13 > > > > > Line search: gnorm after quadratic fit 2.646675787349e+02 > > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > > 36 SNES Function norm 2.646675787349e+02 > > > > > 0 KSP Residual norm 3.630219417922e+01 > > > > > 1 KSP Residual norm 1.546302717349e-12 > > > > > Line search: gnorm after quadratic fit 1.827432666108e+04 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.342968941151e+03 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 8.008633273369e+02 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.490753494196e+02 lambda=1.2345129233072847e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.682474011960e+02 lambda=3.3291959087019770e-03 > > > > > Line search: Cubically determined step, current gnorm > 2.646227701989e+02 lambda=4.0529212866107715e-04 > > > > > 37 SNES Function norm 2.646227701989e+02 > > > > > 0 KSP Residual norm 8.122774697994e+00 > > > > > 1 KSP Residual norm 1.316362046092e-13 > > > > > Line search: gnorm after quadratic fit 4.731092571363e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.030088374328e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm > 2.637462652877e+02 lambda=9.1057248517509397e-03 > > > > > 38 SNES Function norm 2.637462652877e+02 > > > > > 0 KSP Residual norm 2.601520363063e+00 > > > > > 1 KSP Residual norm 1.060764270007e-12 > > > > > Line search: gnorm after quadratic fit 2.536856446094e+02 > > > > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > > > > 39 SNES Function norm 2.536856446094e+02 > > > > > 0 KSP Residual norm 5.447955134327e+01 > > > > > 1 KSP Residual norm 2.556989975730e-12 > > > > > Line search: gnorm after quadratic fit 9.199250935618e+03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.998238940105e+03 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 6.227083769291e+02 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.852215674478e+02 lambda=8.5024965111563117e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.537821339347e+02 lambda=8.5024965111563122e-04 > > > > > Line search: Cubically determined step, current gnorm > 2.536484146652e+02 lambda=2.9594242443314720e-04 > > > > > 40 SNES Function norm 2.536484146652e+02 > > > > > 0 KSP Residual norm 3.357359266965e+01 > > > > > 1 KSP Residual norm 8.485166742752e-11 > > > > > Line search: gnorm after quadratic fit 3.327150899857e+03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 8.660943990394e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.428891921377e+02 lambda=2.2262238648584176e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.550059920785e+02 lambda=3.9120439672600755e-03 > > > > > Line search: Cubically determined step, current gnorm > 2.535425543202e+02 lambda=8.8078244093807846e-04 > > > > > 41 SNES Function norm 2.535425543202e+02 > > > > > 0 KSP Residual norm 1.982789391732e+01 > > > > > 1 KSP Residual norm 1.156473750758e-11 > > > > > Line search: gnorm after quadratic fit 9.648483369708e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.023504841042e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.554919970151e+02 lambda=8.7092873850291869e-03 > > > > > Line search: Cubically determined step, current gnorm > 2.532490636747e+02 lambda=2.4564558988847251e-03 > > > > > 42 SNES Function norm 2.532490636747e+02 > > > > > 0 KSP Residual norm 1.762994613361e+01 > > > > > 1 KSP Residual norm 4.550684860593e-12 > > > > > Line search: gnorm after quadratic fit 6.772107527838e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.370541870778e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.532869639177e+02 lambda=7.7662700854918328e-03 > > > > > Line search: Cubically determined step, current gnorm > 2.527651129995e+02 lambda=3.8686733161537824e-03 > > > > > 43 SNES Function norm 2.527651129995e+02 > > > > > 0 KSP Residual norm 1.559278923951e+01 > > > > > 1 KSP Residual norm 1.060470887103e-11 > > > > > Line search: gnorm after quadratic fit 7.344361373020e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.498001534426e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.530518382567e+02 lambda=7.6730113050967469e-03 > > > > > Line search: Cubically determined step, current gnorm > 2.523423548732e+02 lambda=3.4156098513217236e-03 > > > > > 44 SNES Function norm 2.523423548732e+02 > > > > > 0 KSP Residual norm 1.190500639095e+01 > > > > > 1 KSP Residual norm 6.311739265577e-12 > > > > > Line search: gnorm after quadratic fit 4.875196633557e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.933215922947e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm > 2.516782376717e+02 lambda=9.8878729665301743e-03 > > > > > 45 SNES Function norm 2.516782376717e+02 > > > > > 0 KSP Residual norm 1.003632001309e+01 > > > > > 1 KSP Residual norm 7.039473047666e-13 > > > > > Line search: gnorm after quadratic fit 3.417133560813e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.636443273929e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm > 2.499729768042e+02 lambda=1.5332495922160540e-02 > > > > > 46 SNES Function norm 2.499729768042e+02 > > > > > 0 KSP Residual norm 5.252587112411e+01 > > > > > 1 KSP Residual norm 2.072629114336e-12 > > > > > Line search: gnorm after quadratic fit 7.891803681498e+03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.819076698717e+03 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 5.911876424956e+02 lambda=2.4538865368827514e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.688195882303e+02 lambda=6.5764457912135515e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.500076295129e+02 lambda=6.5764457912135523e-04 > > > > > Line search: Cubically determined step, current gnorm > 2.499390700783e+02 lambda=2.7231956365922875e-04 > > > > > 47 SNES Function norm 2.499390700783e+02 > > > > > 0 KSP Residual norm 4.007648116930e+01 > > > > > 1 KSP Residual norm 5.646654234336e-11 > > > > > Line search: gnorm after quadratic fit 6.276152857499e+03 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 1.418274035925e+03 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 4.785345842563e+02 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 2.665412152699e+02 lambda=8.0607289886479045e-03 > > > > > Line search: Cubically determined step, current gnorm > 2.499109739904e+02 lambda=8.0607289886479045e-04 > > > > > 48 SNES Function norm 2.499109739904e+02 > > > > > 0 KSP Residual norm 1.339756751889e+01 > > > > > 1 KSP Residual norm 2.559175980945e-13 > > > > > Line search: gnorm after quadratic fit 6.052259901869e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current > gnorm 3.217431518450e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm > 2.496541765916e+02 lambda=7.0239599632283649e-03 > > > > > 49 SNES Function norm 2.496541765916e+02 > > > > > 0 KSP Residual norm 5.340771873687e+00 > > > > > 1 KSP Residual norm 1.207454778077e-13 > > > > > Line search: gnorm after quadratic fit 2.760767095070e+02 > > > > > Line search: Cubically determined step, current gnorm > 2.491630276458e+02 lambda=5.0000000000000003e-02 > > > > > 50 SNES Function norm 2.491630276458e+02 > > > > > > > > > > > > > > > On Sat, Aug 26, 2017 at 11:45 PM, Barry Smith > wrote: > > > > > > > > > > > On Aug 26, 2017, at 10:43 PM, zakaryah . > wrote: > > > > > > > > > > > > Hi Barry - many thanks for taking the time to understand my many > problems and providing so much help. > > > > > > > > > > > > The reason I was concerned that I could not alter the linesearch > was when I tried to use bt instead of the L-BFGS default, cp, the code > crashed with an error like "Could not get Jacobian". Maybe this is an > incompatibility like you say, since L-BFGS only uses the initial Jacobian > and I never tried setting the scale type. > > > > > > > > > > > > I took your advice and tried to shrink the problem. First I > tried shrinking by a factor 1000 but this converged very quickly with all > test data I could provide, including the data which was problematic with > the large grid. So I settled for a reduction in size by a factor 125. The > grid size is 13,230. This is a decent test case because the solver fails > to converge with the options I was using before, and it is small enough > that I can run it with the options you suggested (-snes_fd_color -snes_type > newtonls -snes_monitor -snes_linesearch_monitor -ksp_monitor -pc_type lu). > > > > > > > > > > > > The output is 1800 lines long - how shall I share it? > > > > > > > > > > Just email it, that is small enough for email. > > > > > > > > > > Barry > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > On Sat, Aug 26, 2017 at 7:38 PM, Barry Smith > wrote: > > > > > > > > > > > > > On Aug 26, 2017, at 5:56 PM, zakaryah . > wrote: > > > > > > > > > > > > > > I'm using PETSc's SNES methods to solve PDEs which result from > Euler-Lagrange equations for the strain energy of a 3D displacement field. > There is an additional term in the Lagrangian which describes external > forces which arise from various data sets, and that term contains > nonlinearities (field terms higher than linear). The grid has about 1.6e6 > elements, and the displacement field has 3 components at each grid element. > > > > > > > > > > > > > > I'm trying to solve a sequence of successively more > complicated equations, and the latest equation is failing to converge on > some data sets. In particular, the methods were successful for the > infinitesimal bulk strain (compression) energy, as well as the full > infinitesimal strain energy (bulk + shear), but I'm now trying to > generalize to the finite strain, as certain data sets are known to result > from displacement fields for which the infinitesimal strain is a poor > approximation. > > > > > > > > > > > > > > I'm using a DMDA, closely following example 48, and my > preferred solver is L-BFGS. > > > > > > > > > > > > So you are using ? > > > > > > > > > > > > -snes_type qn -snes_qn_type lbfgs > > > > > > > > > > > > > > > > > > > > I have read the FAQs "Why is Newton's method not converging??" > and "Why is my iterative linear solver not converging??"? which have raised > a number of questions: > > > > > > > > > > > > Quasi Newton methods either don't use Jacobians or use only > the initial Jacobian (the idea behind quasi-Newton methods is to > approximate Jacobian information from previous iterations without having > the user compute a Jacobian at each iteration). With PETSc's qn it only > uses the Jacobian if you use the option > > > > > > > > > > > > -snes_qn_scale_type Jacobian > > > > > > > > > > > > otherwise the Jacobian is never computed or used > > > > > > > > > > > > > > > > > > > > > > > > > > Is there documentation for the DMDA/SNES methods somewhere? I > don't understand these very well. For example, I am not allocating any > matrix for the global Jacobian, and I believe this prevents me from > changing the line search. If I'm mistaken I would love to see an example > of changing the line search type while using DMDA/SNES. > > > > > > > > > > > > Whether you provide a Jacobian or not is orthogonal to the > line search. > > > > > > > > > > > > You should be able to change the line search with > > > > > > > > > > > > -snes_linesearch_type bt or nleqerr or basic or l2 or cp > > > > > > > > > > > > not all of them may work with qn > > > > > > > > > > > > > > > > > > > > > > > > > > I don't know how to interpret the linesearch monitor. Even > for problems which are converging properly, the linesearch monitor reports > "lssucceed=0" on every iteration. Is this a problem? > > > > > > > > > > > > It returns a 0 if the line search does not believe it has > achieved "sufficient decrease" in the function norm (or possibly some other > measure of decrease) you should run -snes_linesearch_monitor also with the > option -snes_monitor to see what is happening to the function norm > > > > > > > > > > > > For qn you can add the option > > > > > > > > > > > > -snes_qn_monitor > > > > > > > > > > > > to get more detailed monitoring > > > > > > > > > > > > > > > > > > > > > > > > > > I'm also having trouble understanding the methods for > troubleshooting. I suspect that I've made an error in the analytical > Jacobian, which has a rather large number of non-zero elements, but I have > no idea how to use -snes_type test -snes_test_display. The FAQs mention > that some troubleshooting tools are more useful for small test problems. > How small is small? > > > > > > > > > > > > Tiny, at most a few dozen rows and columns in the Jacobin. > > > > > > > > > > > > You should run without the -snes_test_display information, > what does it say? Does it indicate the Jacobian or report there is likely a > problem? > > > > > > > > > > > > With DMDA you can also use -snes_fd_color to have PETSc > compute the Jacobian for you instead of using your analytical form. If it > works with this, but not your Jacobian then your Jacobian is wrong. > > > > > > > > > > > > > When I try to run the program with -snes_type test > -snes_test_display, I get errors like: > > > > > > > > > > > > > > [0]PETSC ERROR: Argument out of range [0]PETSC ERROR: Local > index 1076396032 too large 4979879 (max) at 0 > > > > > > > > > > > > > > The second size is 1 less than the number of field elements, > while the first number seems too large for any aspect of the problem - the > Jacobian has at most 59 non-zero columns per row. > > > > > > > > > > > > > > Because I suspect a possible error in the Jacobian, I ran with > -snes_mf_operator -pc_type ksp -ksp_ksp_rtol 1e-12 and observed very > similar failure to converge (diverging residual) as with the explicit > Jacobian. > > > > > > > > > > > > What do you get with -ksp_monitor -ksp_ksp_monitor it > sounds like the true Jacobian is either very ill-conditioned or your > function evaluation is wrong. > > > > > > > > > > > > > Do I need to set an SNES method which is somehow compatible > with the "matrix-free" approach? If I instead use -snes_mf, the problem > seems to converge, but horrendously slowly (true residual relative decrease > by about 1e-5 per iteration). I suppose this supports my suspicion that > the Jacobian is incorrect but doesn't really suggest a solution. > > > > > > > > > > > > > > Is it possible that the analytical Jacobian is correct, but > somehow pathological, which causes the SNES to diverge? > > > > > > > > > > > > Yes > > > > > > > > > > > > > Neither the Jacobian nor the function have singularities. > > > > > > > > > > > > > > Thanks for any help you can provide! > > > > > > > > > > > > Try really hard to set up a small problem (like just use a > very coarse grid) to experiment with as you try to get convergence. Using a > big problem for debugging convergence is a recipe for pain. > > > > > > > > > > > > Also since you have a Jacobian I would start with > -snes_fd_color -snes_type ls -snes_monitor -snes_linesearch_monitor > -ksp_monitor -pc_type lu (not on a huge problem), what happens? Send the > output > > > > > > > > > > > > Barry > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Sun Aug 27 20:33:49 2017 From: bsmith at mcs.anl.gov (Barry Smith) Date: Sun, 27 Aug 2017 20:33:49 -0500 Subject: [petsc-users] A number of questions about DMDA with SNES and Quasi-Newton methods In-Reply-To: References: <020DAED9-AAAD-4741-976B-BB2EF6C79D3F@mcs.anl.gov> <5BF530F6-8D79-47E6-B2C5-B0702FF2AA59@mcs.anl.gov> <7EE84495-4346-4BFB-B9AD-BCAA3C722461@mcs.anl.gov> <08AA1273-062D-4FDD-8709-40AA1FE8AA92@mcs.anl.gov> <06932E72-E8F3-4EA8-889F-A570AD660E32@mcs.anl.gov> Message-ID: > On Aug 27, 2017, at 6:51 PM, zakaryah . wrote: > > OK, I'm with you. Here's my call to DMDACreate: > > ierr = DMDACreate3d(PETSC_COMM_WORLD, DM_BOUNDARY_NONE, DM_BOUNDARY_NONE, DM_BOUNDARY_NONE, DMDA_STENCIL_BOX, mp->W, mp->H, mp->D,PETSC_DECIDE, PETSC_DECIDE, PETSC_DECIDE, 3, 1, NULL, NULL, NULL, &(mp->PETSc_da));CHKERRQ(ierr); > > The grid dimensions are mp->W x mp->H x mp->D, and there are three degrees of freedom at each grid location (x, y, z terms of field). In my Jacobian routine, at the row representing grid coordinate ix, iy, iz, and each of the 3 dof, I set values in columns corresponding to ix+/-1, iy+/-1, iz+/-1, but not all 27 such coordinates (the Jacobian is zero at the 8 corners of the cube). The code for the Jacobian is explicit at the boundaries. In other words, the ix-1 terms are only set when ix>0. > > I'm not sure how the code can be detecting a new non-zero element in the Jacobian that early in the code. As I said before, I do not explicitly allocate or set the Jacobian anywhere, following example 48 which also uses a DMDA. The DMDA preallocates the matrix based on the stencil information you provide. It seems your matrix entries are within the preallocated space; maybe the boundary condition has a wider stencil? Anyways you need to use the debugger to find out why the code is allocating into a space it shouldn't (based on the DMDA). Barry > > > > > On Sun, Aug 27, 2017 at 7:29 PM, Barry Smith wrote: > > > On Aug 27, 2017, at 6:19 PM, zakaryah . wrote: > > > > Heh, I guess it's at least a sign that the two fd methods agreed. This takes me back to my earlier question - when I call MatSetOption(jac,MAT_NEW_NONZERO_LOCATION_ERR,PETSC_FALSE), what is jac? Do I need to preallocate it? Do I need to get it from the SNES? Do I need to set that matrix as the SNES Jacobian? Do I allocate the actual number of non-zero rows, or the entirety of the stencil? I notice that -snes_test_display reports values for the entire stencil, even though of the 27 points in the stencil, only 19 can be non-zero. > > Back up a minute I didn't read your previous email well enough, sorry. See below > > > > > On Sun, Aug 27, 2017 at 5:51 PM, Barry Smith wrote: > > > > Sorry this a flaw with the current release. Call > > > > MatSetOption(jac,MAT_NEW_NONZERO_LOCATION_ERR,PETSC_FALSE) > > > > before the call to the solver. > > > > > > > On Aug 27, 2017, at 12:54 PM, zakaryah . wrote: > > > > > > Is it suspicious that the KSP converges so quickly? I have no experience with how the solvers behave on such small grids. > > > > > > Also, I ran the code with -snes_type test on a very small grid (1530 elements). The simpler version of the PDE ran fine, and showed good agreement of the matrices. However, the more complicated version crashes with the following errors: > > > > > > Testing hand-coded Jacobian, if the ratio is > > > > > > O(1.e-8), the hand-coded Jacobian is probably correct. > > > > > > Run with -snes_test_display to show difference > > > > > > of hand-coded and finite difference Jacobian. > > > > > > [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- > > > > > > [0]PETSC ERROR: Argument out of range > > > > > > [0]PETSC ERROR: Inserting a new nonzero at (7,0) in the matrix > > > > > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. > > > > > > [0]PETSC ERROR: Petsc Release Version 3.7.3, Jul, 24, 2016 > > > > > > [0]PETSC ERROR: #1 MatSetValues_SeqAIJ() line 484 in /PETSc/build/petsc-3.7.3/src/mat/impls/aij/seq/aij.c > > > > > > [0]PETSC ERROR: #2 MatSetValues() line 1190 in /PETSc/build/petsc-3.7.3/src/mat/interface/matrix.c > > > > > > [0]PETSC ERROR: #3 MatSetValuesLocal() line 2053 in /PETSc/build/petsc-3.7.3/src/mat/interface/matrix.c > > > > > > [0]PETSC ERROR: #4 MatSetValuesStencil() line 1447 in /PETSc/build/petsc-3.7.3/src/mat/interface/matrix.c > > > > > > Does this indicate a bug in the Jacobian calculation? I don't think I set values outside of the stencil... > > Yes something is definitely wrong, you are inserting a value in a location the matrix was not expecting. What are your arguments to DMDACreate()? For stencil width and stencil type? You can run in the debugger to see why the stencil value doesn't "fit". > > Barry > > > > > > > > > > > > On Sun, Aug 27, 2017 at 12:14 AM, zakaryah . wrote: > > > Sure - it was this: > > > > > > mpiexec -n 1 -snes_fd_color -snes_type newtonls -snes_monitor -snes_linesearch_monitor -ksp_monitor -pc_type lu > > > > > > On Sun, Aug 27, 2017 at 12:11 AM, Barry Smith wrote: > > > > > > > On Aug 26, 2017, at 10:55 PM, zakaryah . wrote: > > > > > > > > Yes, except I changed "-snes_type ls" to "-snes_type newtonls" because PETSc complained that ls wasn't a known method. > > > > > > Sorry, my memory is not as good as it used to be; but what other options did you use? Send the exact command line. > > > > > > > > > Barry > > > ' > > > > > > > > On Sat, Aug 26, 2017 at 11:52 PM, Barry Smith wrote: > > > > > > > > My exact options did you run with? > > > > > > > > > On Aug 26, 2017, at 10:48 PM, zakaryah . wrote: > > > > > > > > > > Here's the output, from the data set which does not converge with l-bfgs: > > > > > > > > > > 0 SNES Function norm 1.370293318432e+04 > > > > > 0 KSP Residual norm 7.457506389218e+02 > > > > > 1 KSP Residual norm 2.244764079994e-10 > > > > > Line search: gnorm after quadratic fit 6.541298279196e+05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.963717927372e+04 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.788909416707e+04 lambda=2.5000000000000001e-02 > > > > > Line search: Cubically determined step, current gnorm 1.340565762719e+04 lambda=1.2500000000000001e-02 > > > > > 1 SNES Function norm 1.340565762719e+04 > > > > > 0 KSP Residual norm 4.096066553372e+02 > > > > > 1 KSP Residual norm 3.313671167444e-11 > > > > > Line search: gnorm after quadratic fit 1.113749573695e+06 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.406390140546e+05 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.126781917443e+04 lambda=2.5000000000000001e-02 > > > > > Line search: Cubically determined step, current gnorm 1.272988597973e+04 lambda=1.2500000000000001e-02 > > > > > 2 SNES Function norm 1.272988597973e+04 > > > > > 0 KSP Residual norm 8.291344597817e+01 > > > > > 1 KSP Residual norm 7.182258362182e-12 > > > > > Line search: gnorm after quadratic fit 1.121913743889e+04 > > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > > 3 SNES Function norm 1.121913743889e+04 > > > > > 0 KSP Residual norm 6.830535877014e+01 > > > > > 1 KSP Residual norm 3.629826411580e-12 > > > > > Line search: gnorm after quadratic fit 9.966344973786e+03 > > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > > 4 SNES Function norm 9.966344973786e+03 > > > > > 0 KSP Residual norm 5.137691531345e+01 > > > > > 1 KSP Residual norm 1.954502098181e-12 > > > > > Line search: gnorm after quadratic fit 8.905508641232e+03 > > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > > 5 SNES Function norm 8.905508641232e+03 > > > > > 0 KSP Residual norm 4.295019262963e+01 > > > > > 1 KSP Residual norm 1.581527994925e-12 > > > > > Line search: gnorm after quadratic fit 7.599173694189e+03 > > > > > Line search: Quadratically determined step, lambda=1.4157226463489950e-01 > > > > > 6 SNES Function norm 7.599173694189e+03 > > > > > 0 KSP Residual norm 3.520472291520e+01 > > > > > 1 KSP Residual norm 1.169994130568e-12 > > > > > Line search: gnorm after quadratic fit 6.797214843928e+03 > > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > > 7 SNES Function norm 6.797214843928e+03 > > > > > 0 KSP Residual norm 2.683523206056e+01 > > > > > 1 KSP Residual norm 9.039858014119e-13 > > > > > Line search: gnorm after quadratic fit 6.098038917364e+03 > > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > > 8 SNES Function norm 6.098038917364e+03 > > > > > 0 KSP Residual norm 2.300710560681e+01 > > > > > 1 KSP Residual norm 1.010402303464e-12 > > > > > Line search: gnorm after quadratic fit 5.486151385552e+03 > > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > > 9 SNES Function norm 5.486151385552e+03 > > > > > 0 KSP Residual norm 2.824628827619e+01 > > > > > 1 KSP Residual norm 1.009589866569e-12 > > > > > Line search: gnorm after quadratic fit 4.964991021247e+03 > > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > > 10 SNES Function norm 4.964991021247e+03 > > > > > 0 KSP Residual norm 6.285926028595e+01 > > > > > 1 KSP Residual norm 2.833546214180e-12 > > > > > Line search: gnorm after quadratic fit 2.100041391472e+04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.804051080767e+03 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm 4.893296169579e+03 lambda=2.5000000000000001e-02 > > > > > 11 SNES Function norm 4.893296169579e+03 > > > > > 0 KSP Residual norm 1.688978282804e+01 > > > > > 1 KSP Residual norm 5.927677470786e-13 > > > > > Line search: gnorm after quadratic fit 4.400894622431e+03 > > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > > 12 SNES Function norm 4.400894622431e+03 > > > > > 0 KSP Residual norm 1.481197699600e+01 > > > > > 1 KSP Residual norm 4.522572128105e-13 > > > > > Line search: Using full step: fnorm 4.400894622431e+03 gnorm 2.094971849007e+03 > > > > > 13 SNES Function norm 2.094971849007e+03 > > > > > 0 KSP Residual norm 3.514164563318e+00 > > > > > 1 KSP Residual norm 3.022385947499e-13 > > > > > Line search: gnorm after quadratic fit 1.687641025382e+03 > > > > > Line search: Quadratically determined step, lambda=2.0307116693368590e-01 > > > > > 14 SNES Function norm 1.687641025382e+03 > > > > > 0 KSP Residual norm 2.138591884686e+00 > > > > > 1 KSP Residual norm 4.023500814078e-14 > > > > > Line search: Using full step: fnorm 1.687641025382e+03 gnorm 1.131934218470e+03 > > > > > 15 SNES Function norm 1.131934218470e+03 > > > > > 0 KSP Residual norm 3.245035110327e+00 > > > > > 1 KSP Residual norm 1.293626215269e-13 > > > > > Line search: Using full step: fnorm 1.131934218470e+03 gnorm 7.340573607307e+02 > > > > > 16 SNES Function norm 7.340573607307e+02 > > > > > 0 KSP Residual norm 1.957698957904e+00 > > > > > 1 KSP Residual norm 3.444648967078e-13 > > > > > Line search: Using full step: fnorm 7.340573607307e+02 gnorm 5.024723505168e+02 > > > > > 17 SNES Function norm 5.024723505168e+02 > > > > > 0 KSP Residual norm 2.510538703839e+00 > > > > > 1 KSP Residual norm 8.570440675253e-14 > > > > > Line search: gnorm after quadratic fit 4.548776456608e+02 > > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > > 18 SNES Function norm 4.548776456608e+02 > > > > > 0 KSP Residual norm 6.741705718178e-01 > > > > > 1 KSP Residual norm 1.650556120809e-14 > > > > > Line search: Using full step: fnorm 4.548776456608e+02 gnorm 1.351189086642e+02 > > > > > 19 SNES Function norm 1.351189086642e+02 > > > > > 0 KSP Residual norm 7.653741241950e+00 > > > > > 1 KSP Residual norm 8.326848236950e-14 > > > > > Line search: gnorm after quadratic fit 4.215455105006e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.889750369356e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.358691836999e+02 lambda=1.0303015930243279e-02 > > > > > Line search: Cubically determined step, current gnorm 1.348911963390e+02 lambda=3.5279526770504110e-03 > > > > > 20 SNES Function norm 1.348911963390e+02 > > > > > 0 KSP Residual norm 4.209281176918e+00 > > > > > 1 KSP Residual norm 1.233232881375e-13 > > > > > Line search: gnorm after quadratic fit 1.860023264470e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.413911132196e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm 1.339597869053e+02 lambda=1.5787957598629023e-02 > > > > > 21 SNES Function norm 1.339597869053e+02 > > > > > 0 KSP Residual norm 1.718484765841e+00 > > > > > 1 KSP Residual norm 6.666016296543e-14 > > > > > Line search: gnorm after quadratic fit 1.326878521472e+02 > > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > > 22 SNES Function norm 1.326878521472e+02 > > > > > 0 KSP Residual norm 1.515373499919e+00 > > > > > 1 KSP Residual norm 2.259154130795e-12 > > > > > Line search: gnorm after quadratic fit 1.226907316391e+02 > > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > > 23 SNES Function norm 1.226907316391e+02 > > > > > 0 KSP Residual norm 1.080252936903e+00 > > > > > 1 KSP Residual norm 1.847020526683e-14 > > > > > Line search: gnorm after quadratic fit 1.163632111851e+02 > > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > > 24 SNES Function norm 1.163632111851e+02 > > > > > 0 KSP Residual norm 2.491746958382e+00 > > > > > 1 KSP Residual norm 6.389134193637e-14 > > > > > Line search: gnorm after quadratic fit 1.345487153563e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.169738363622e+02 lambda=4.4108900954515480e-02 > > > > > Line search: Cubically determined step, current gnorm 1.152177638108e+02 lambda=1.9997442889243631e-02 > > > > > 25 SNES Function norm 1.152177638108e+02 > > > > > 0 KSP Residual norm 5.364385501004e+00 > > > > > 1 KSP Residual norm 8.457149562463e-14 > > > > > Line search: gnorm after quadratic fit 2.722095758964e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.480946353374e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm 1.150680255994e+02 lambda=6.3560128131639167e-03 > > > > > 26 SNES Function norm 1.150680255994e+02 > > > > > 0 KSP Residual norm 4.302025268263e+00 > > > > > 1 KSP Residual norm 1.017526937941e-13 > > > > > Line search: gnorm after quadratic fit 1.956300983573e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.318600522939e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm 1.147123505014e+02 lambda=7.6060788653548803e-03 > > > > > 27 SNES Function norm 1.147123505014e+02 > > > > > 0 KSP Residual norm 6.195463111324e+00 > > > > > 1 KSP Residual norm 1.235283250361e-13 > > > > > Line search: gnorm after quadratic fit 3.324821547049e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.612593208504e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.147389525772e+02 lambda=6.1750939181374294e-03 > > > > > Line search: Cubically determined step, current gnorm 1.145411432123e+02 lambda=3.0078592586792975e-03 > > > > > 28 SNES Function norm 1.145411432123e+02 > > > > > 0 KSP Residual norm 1.454704250187e+01 > > > > > 1 KSP Residual norm 2.368485174123e-13 > > > > > Line search: gnorm after quadratic fit 1.216293873116e+03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.796524621727e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.359314163651e+02 lambda=1.4867675803955788e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.146009802557e+02 lambda=1.4867675803955788e-03 > > > > > Line search: Cubically determined step, current gnorm 1.145096815033e+02 lambda=5.5250912472932839e-04 > > > > > 29 SNES Function norm 1.145096815033e+02 > > > > > 0 KSP Residual norm 3.430451345093e+01 > > > > > 1 KSP Residual norm 1.069396165938e-12 > > > > > Line search: gnorm after quadratic fit 1.161329407098e+04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.260690718050e+03 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.696806489042e+02 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.960149915648e+02 lambda=1.1276129246469476e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.158113641658e+02 lambda=1.5873910451430554e-03 > > > > > Line search: Cubically determined step, current gnorm 1.145062232916e+02 lambda=1.5873910451430555e-04 > > > > > 30 SNES Function norm 1.145062232916e+02 > > > > > 0 KSP Residual norm 2.662578971526e+01 > > > > > 1 KSP Residual norm 5.464011789728e-13 > > > > > Line search: gnorm after quadratic fit 4.375119254490e+03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.038018103928e+03 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.169328002874e+02 lambda=2.3789161387159519e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.262835432714e+02 lambda=5.9737415571960795e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.145626045197e+02 lambda=5.9737415571960802e-04 > > > > > Line search: Cubically determined step, current gnorm 1.144968604079e+02 lambda=1.6421773527706333e-04 > > > > > 31 SNES Function norm 1.144968604079e+02 > > > > > 0 KSP Residual norm 6.322033697338e+01 > > > > > 1 KSP Residual norm 1.507157991448e-12 > > > > > Line search: gnorm after quadratic fit 5.809243699277e+04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.460487584142e+03 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.893183483197e+03 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.960337007072e+02 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.771527792790e+02 lambda=5.3912931685137378e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.150137639707e+02 lambda=5.3912931685137376e-04 > > > > > Line search: Cubically determined step, current gnorm 1.144964484571e+02 lambda=5.3912931685137380e-05 > > > > > 32 SNES Function norm 1.144964484571e+02 > > > > > 0 KSP Residual norm 3.859510930996e+01 > > > > > 1 KSP Residual norm 8.069118044382e-13 > > > > > Line search: gnorm after quadratic fit 1.106329930525e+04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.155884463041e+03 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.933963819094e+02 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.849629797377e+02 lambda=9.7744286136270241e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.150857687050e+02 lambda=9.7744286136270254e-04 > > > > > Line search: Cubically determined step, current gnorm 1.144922906340e+02 lambda=9.7744286136270254e-05 > > > > > 33 SNES Function norm 1.144922906340e+02 > > > > > 0 KSP Residual norm 4.952038022394e+01 > > > > > 1 KSP Residual norm 7.460263245424e-13 > > > > > Line search: gnorm after quadratic fit 3.005091127220e+04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.229308416025e+03 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.138600794682e+03 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.390856262238e+02 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.394997214983e+02 lambda=4.4582997750629580e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.146836358799e+02 lambda=4.4582997750629581e-04 > > > > > Line search: Cubically determined step, current gnorm 1.144895966587e+02 lambda=4.7644082443915877e-05 > > > > > 34 SNES Function norm 1.144895966587e+02 > > > > > 0 KSP Residual norm 1.146914786457e+02 > > > > > 1 KSP Residual norm 4.791627042400e-12 > > > > > Line search: gnorm after quadratic fit 2.601294145944e+05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.324148513778e+04 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.247478406023e+03 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.200340900661e+03 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.696223112300e+02 lambda=6.1514413845115794e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.342365431983e+02 lambda=1.7502929694284564e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.146686063035e+02 lambda=1.7502929694284566e-04 > > > > > Line search: Cubically determined step, current gnorm 1.144895868489e+02 lambda=1.7502929694284566e-05 > > > > > 35 SNES Function norm 1.144895868489e+02 > > > > > 0 KSP Residual norm 6.311017209658e+01 > > > > > 1 KSP Residual norm 8.384445939117e-13 > > > > > Line search: gnorm after quadratic fit 5.781533400572e+04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.419557746031e+03 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.886081770030e+03 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.945810143740e+02 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.767820854837e+02 lambda=5.3859001959289735e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.150034040559e+02 lambda=5.3859001959289732e-04 > > > > > Line search: Cubically determined step, current gnorm 1.144891501665e+02 lambda=5.3859001959289732e-05 > > > > > 36 SNES Function norm 1.144891501665e+02 > > > > > 0 KSP Residual norm 3.880748384332e+01 > > > > > 1 KSP Residual norm 6.400339290453e-13 > > > > > Line search: gnorm after quadratic fit 1.122504184426e+04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.180728237366e+03 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.987870621566e+02 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.863711604331e+02 lambda=9.8150771384688824e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.150916783781e+02 lambda=9.8150771384688824e-04 > > > > > Line search: Cubically determined step, current gnorm 1.144850837411e+02 lambda=9.8150771384688832e-05 > > > > > 37 SNES Function norm 1.144850837411e+02 > > > > > 0 KSP Residual norm 4.811537498557e+01 > > > > > 1 KSP Residual norm 9.738167670242e-13 > > > > > Line search: gnorm after quadratic fit 2.784098355218e+04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.885118868254e+03 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.074843354348e+03 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.255202820836e+02 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.365202996130e+02 lambda=4.3204204582016374e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.146504919412e+02 lambda=4.3204204582016374e-04 > > > > > Line search: Cubically determined step, current gnorm 1.144822306241e+02 lambda=5.0376546850227848e-05 > > > > > 38 SNES Function norm 1.144822306241e+02 > > > > > 0 KSP Residual norm 1.120914002482e+02 > > > > > 1 KSP Residual norm 5.452125292284e-12 > > > > > Line search: gnorm after quadratic fit 2.427186680567e+05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.112196656857e+04 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.967397366072e+03 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.149551659770e+03 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.529630886791e+02 lambda=6.0885216927030559e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.315267519231e+02 lambda=1.6656233536183130e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.146353659250e+02 lambda=1.6656233536183130e-04 > > > > > Line search: Cubically determined step, current gnorm 1.144820487391e+02 lambda=1.6656233536183130e-05 > > > > > 39 SNES Function norm 1.144820487391e+02 > > > > > 0 KSP Residual norm 7.182416170980e+01 > > > > > 1 KSP Residual norm 1.292147133333e-12 > > > > > Line search: gnorm after quadratic fit 8.255331293322e+04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.302939895170e+04 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.501228089911e+03 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.185010378583e+02 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.088179821424e+02 lambda=5.7489510178867142e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.168272901121e+02 lambda=9.7452649444612811e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144951972300e+02 lambda=9.7452649444612822e-05 > > > > > Line search: Cubically determined step, current gnorm 1.144807676687e+02 lambda=2.2399506502463798e-05 > > > > > 40 SNES Function norm 1.144807676687e+02 > > > > > 0 KSP Residual norm 1.728679810285e+02 > > > > > 1 KSP Residual norm 3.878068639716e-12 > > > > > Line search: gnorm after quadratic fit 9.011020578535e+05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.111818830011e+05 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.504789858103e+04 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.754312133162e+03 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.212492111975e+02 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.199969180537e+02 lambda=2.6424184504193135e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.154794639440e+02 lambda=2.6424184504193136e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144880673342e+02 lambda=2.6424184504193136e-05 > > > > > Line search: Cubically determined step, current gnorm 1.144805461570e+02 lambda=3.8712107591125690e-06 > > > > > 41 SNES Function norm 1.144805461570e+02 > > > > > 0 KSP Residual norm 4.162780846202e+02 > > > > > 1 KSP Residual norm 1.732341544934e-11 > > > > > Line search: gnorm after quadratic fit 1.355673864369e+07 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.747523002884e+06 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.342205048417e+05 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.425635699680e+04 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.882150659178e+03 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.259664786336e+03 lambda=3.1250000000000002e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.653670676209e+02 lambda=1.5625000000000001e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.453655830144e+02 lambda=5.8237455565260388e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.147659525018e+02 lambda=5.8237455565260393e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144827915995e+02 lambda=5.8237455565260400e-06 > > > > > Line search: Cubically determined step, current gnorm 1.144805080017e+02 lambda=6.6689295146509104e-07 > > > > > 42 SNES Function norm 1.144805080017e+02 > > > > > 0 KSP Residual norm 1.004135512581e+03 > > > > > 1 KSP Residual norm 3.867626041000e-09 > > > > > Line search: gnorm after quadratic fit 1.832578994882e+08 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.269698278878e+07 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.792476589915e+06 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.420660371083e+05 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.321686926168e+04 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.548358078234e+03 lambda=3.1250000000000002e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.429504802276e+03 lambda=1.5625000000000001e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.317723385004e+02 lambda=7.8125000000000004e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.460079723095e+02 lambda=2.5078917343692407e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.147908977725e+02 lambda=2.5078917343692408e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144833604238e+02 lambda=2.5078917343692412e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144805106824e+02 lambda=2.5078917343692411e-07 > > > > > Line search: Cubically determined step, current gnorm 1.144805014337e+02 lambda=1.1468707119027746e-07 > > > > > 43 SNES Function norm 1.144805014337e+02 > > > > > 0 KSP Residual norm 2.418614573592e+03 > > > > > 1 KSP Residual norm 6.085078742847e-10 > > > > > Line search: gnorm after quadratic fit 2.598476259775e+09 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.262759415873e+08 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.116845970403e+07 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.250465130250e+06 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.863493884574e+05 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.501468163771e+04 lambda=3.1250000000000002e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.482658980483e+04 lambda=1.5625000000000001e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.802395557883e+03 lambda=7.8125000000000004e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.788149582374e+02 lambda=3.9062500000000002e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.248828337038e+02 lambda=1.8333058767960295e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.186285836222e+02 lambda=3.7550993478654105e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.145209710139e+02 lambda=3.7550993478654107e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144808670668e+02 lambda=3.7550993478654111e-07 > > > > > Line search: Cubically determined step, current gnorm 1.144805012252e+02 lambda=3.7550993478654114e-08 > > > > > 44 SNES Function norm 1.144805012252e+02 > > > > > 0 KSP Residual norm 1.432476672735e+03 > > > > > 1 KSP Residual norm 7.850524783892e-11 > > > > > Line search: gnorm after quadratic fit 5.336191593632e+08 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.625576866625e+07 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.181408387845e+06 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.003310644422e+06 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.236384273292e+05 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.658430638069e+04 lambda=3.1250000000000002e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.977463068161e+03 lambda=1.5625000000000001e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.674238499253e+02 lambda=7.8125000000000004e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.333616820791e+02 lambda=3.3764776729281175e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.161349153752e+02 lambda=4.0497161764116874e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144966925969e+02 lambda=4.0497161764116874e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144806214839e+02 lambda=4.0497161764116878e-07 > > > > > Line search: Cubically determined step, current gnorm 1.144804979966e+02 lambda=5.6339112427782378e-08 > > > > > 45 SNES Function norm 1.144804979966e+02 > > > > > 0 KSP Residual norm 3.453401579761e+03 > > > > > 1 KSP Residual norm 4.197968028126e-09 > > > > > Line search: gnorm after quadratic fit 7.554006183767e+09 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.471974940372e+08 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.191613865049e+08 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.509784334249e+07 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.943752478560e+06 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.597601716755e+05 lambda=3.1250000000000002e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.775572331075e+04 lambda=1.5625000000000001e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.418045407608e+03 lambda=7.8125000000000004e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.357066758731e+03 lambda=3.9062500000000002e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.859267839080e+02 lambda=1.9531250000000001e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.501494912160e+02 lambda=7.5160826909319168e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.148144926477e+02 lambda=7.5160826909319171e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144837498478e+02 lambda=7.5160826909319179e-07 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144805227746e+02 lambda=7.5160826909319182e-08 > > > > > Line search: Cubically determined step, current gnorm 1.144804974438e+02 lambda=9.6864021663644795e-09 > > > > > 46 SNES Function norm 1.144804974438e+02 > > > > > 0 KSP Residual norm 8.345139428850e+03 > > > > > 1 KSP Residual norm 1.027819754739e-09 > > > > > Line search: gnorm after quadratic fit 1.061319903906e+11 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.325012985379e+10 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.652236226640e+09 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.055533971630e+08 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.546607716763e+07 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.134442858835e+06 lambda=3.1250000000000002e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.839168570687e+05 lambda=1.5625000000000001e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.830568178626e+04 lambda=7.8125000000000004e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.201776786081e+03 lambda=3.9062500000000002e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.540520468013e+03 lambda=1.9531250000000001e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.573504890506e+02 lambda=9.7656250000000005e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.516203908013e+02 lambda=3.2703670177372021e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.148480075676e+02 lambda=3.2703670177372022e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144841475328e+02 lambda=3.2703670177372023e-07 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144805305720e+02 lambda=3.2703670177372021e-08 > > > > > Line search: Cubically determined step, current gnorm 1.144804974367e+02 lambda=3.2703670177372025e-09 > > > > > 47 SNES Function norm 1.144804974367e+02 > > > > > 0 KSP Residual norm 4.668983500382e+03 > > > > > 1 KSP Residual norm 1.398997665317e-09 > > > > > Line search: gnorm after quadratic fit 1.865309565532e+10 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.336975299727e+09 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.934905088739e+08 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.704520478641e+07 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.728477809448e+06 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.193001670096e+05 lambda=3.1250000000000002e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.610673238239e+04 lambda=1.5625000000000001e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.354711683605e+04 lambda=7.8125000000000004e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.589557246433e+03 lambda=3.9062500000000002e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.367851970709e+02 lambda=1.9531250000000001e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.136930269795e+02 lambda=9.0316845802227864e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.172186635069e+02 lambda=1.5831613287181393e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.145074017254e+02 lambda=1.5831613287181394e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144807499816e+02 lambda=1.5831613287181396e-07 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144804983345e+02 lambda=1.5831613287181397e-08 > > > > > Line search: Cubically determined step, current gnorm 1.144804971346e+02 lambda=5.2932921109871310e-09 > > > > > 48 SNES Function norm 1.144804971346e+02 > > > > > 0 KSP Residual norm 1.132678078317e+04 > > > > > 1 KSP Residual norm 2.477518733314e-10 > > > > > Line search: gnorm after quadratic fit 2.654659022365e+11 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.315296223725e+10 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.136635677074e+09 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.152507060235e+08 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.397060094478e+07 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.898362012287e+06 lambda=3.1250000000000002e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.685179520906e+05 lambda=1.5625000000000001e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.194040779842e+05 lambda=7.8125000000000004e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.606415730227e+04 lambda=3.9062500000000002e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.902698091972e+03 lambda=1.9531250000000001e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.521549384652e+02 lambda=9.7656250000000005e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.288999778994e+02 lambda=4.1899746703195281e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.157880829786e+02 lambda=4.5470218451893824e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144935741206e+02 lambda=4.5470218451893828e-07 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144806232638e+02 lambda=4.5470218451893831e-08 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144804979250e+02 lambda=4.5470218451893835e-09 > > > > > Line search: Cubically determined step, current gnorm 1.144804970825e+02 lambda=9.0293679903918216e-10 > > > > > 49 SNES Function norm 1.144804970825e+02 > > > > > 0 KSP Residual norm 2.712544829144e+04 > > > > > 1 KSP Residual norm 4.949246309677e-09 > > > > > Line search: gnorm after quadratic fit 3.650846005745e+12 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.565321055911e+11 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.711080201118e+10 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.150022242308e+09 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.965954117985e+08 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.128096393645e+08 lambda=3.1250000000000002e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.429702091584e+07 lambda=1.5625000000000001e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.841819946536e+06 lambda=7.8125000000000004e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.465032956946e+05 lambda=3.9062500000000002e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.594210253794e+04 lambda=1.9531250000000001e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.141110278944e+03 lambda=9.7656250000000005e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.306952279045e+03 lambda=4.8828125000000003e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.754164864338e+02 lambda=2.4414062500000001e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.476861367158e+02 lambda=9.2451761406722810e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.147929263780e+02 lambda=9.2451761406722810e-07 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144836022952e+02 lambda=9.2451761406722821e-08 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144805271860e+02 lambda=9.2451761406722831e-09 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.144804972895e+02 lambda=9.2451761406722839e-10 > > > > > Line search: Cubically determined step, current gnorm 1.144804970737e+02 lambda=1.5633616333063305e-10 > > > > > 50 SNES Function norm 1.144804970737e+02 > > > > > 0 SNES Function norm 2.308693894796e+03 > > > > > 0 KSP Residual norm 8.981999720532e+00 > > > > > 1 KSP Residual norm 2.363170936183e-13 > > > > > Line search: Using full step: fnorm 2.308693894796e+03 gnorm 7.571661187318e+02 > > > > > 1 SNES Function norm 7.571661187318e+02 > > > > > 0 KSP Residual norm 2.149614048903e+00 > > > > > 1 KSP Residual norm 9.511247057888e-13 > > > > > Line search: Using full step: fnorm 7.571661187318e+02 gnorm 4.450081004997e+02 > > > > > 2 SNES Function norm 4.450081004997e+02 > > > > > 0 KSP Residual norm 1.706469075123e+01 > > > > > 1 KSP Residual norm 5.803815175472e-13 > > > > > Line search: gnorm after quadratic fit 1.510518198899e+03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.850796532980e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.515983139755e+02 lambda=2.0602556887689423e-02 > > > > > Line search: Cubically determined step, current gnorm 4.434800867235e+02 lambda=8.2396279492937211e-03 > > > > > 3 SNES Function norm 4.434800867235e+02 > > > > > 0 KSP Residual norm 3.208587171626e+00 > > > > > 1 KSP Residual norm 1.099072610659e-13 > > > > > Line search: gnorm after quadratic fit 4.080637194736e+02 > > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > > 4 SNES Function norm 4.080637194736e+02 > > > > > 0 KSP Residual norm 8.136557176540e+00 > > > > > 1 KSP Residual norm 8.800137844173e-13 > > > > > Line search: gnorm after quadratic fit 5.261656549654e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.131114070934e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm 4.031614746044e+02 lambda=2.4674842039461482e-02 > > > > > 5 SNES Function norm 4.031614746044e+02 > > > > > 0 KSP Residual norm 7.609918907567e+00 > > > > > 1 KSP Residual norm 1.613159932655e-13 > > > > > Line search: gnorm after quadratic fit 5.353908064984e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.110480554132e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm 3.991168240716e+02 lambda=2.3079500036735322e-02 > > > > > 6 SNES Function norm 3.991168240716e+02 > > > > > 0 KSP Residual norm 3.800845472041e+00 > > > > > 1 KSP Residual norm 4.841682188278e-13 > > > > > Line search: gnorm after quadratic fit 3.787886582952e+02 > > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > > 7 SNES Function norm 3.787886582952e+02 > > > > > 0 KSP Residual norm 1.892621919219e+00 > > > > > 1 KSP Residual norm 3.576655371800e-12 > > > > > Line search: gnorm after quadratic fit 3.440181918909e+02 > > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > > 8 SNES Function norm 3.440181918909e+02 > > > > > 0 KSP Residual norm 3.559759789147e+00 > > > > > 1 KSP Residual norm 8.347521826622e-13 > > > > > Line search: gnorm after quadratic fit 3.287993515195e+02 > > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > > 9 SNES Function norm 3.287993515195e+02 > > > > > 0 KSP Residual norm 1.825073540507e+00 > > > > > 1 KSP Residual norm 8.352745008123e-14 > > > > > Line search: Using full step: fnorm 3.287993515195e+02 gnorm 2.710650507416e+02 > > > > > 10 SNES Function norm 2.710650507416e+02 > > > > > 0 KSP Residual norm 7.568432945608e-01 > > > > > 1 KSP Residual norm 2.780715252274e-14 > > > > > Line search: Using full step: fnorm 2.710650507416e+02 gnorm 1.513359047342e+02 > > > > > 11 SNES Function norm 1.513359047342e+02 > > > > > 0 KSP Residual norm 9.387460484575e+00 > > > > > 1 KSP Residual norm 7.091233040676e-13 > > > > > Line search: gnorm after quadratic fit 3.998857979851e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.060972049714e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm 1.512140169420e+02 lambda=5.4338709720680610e-03 > > > > > 12 SNES Function norm 1.512140169420e+02 > > > > > 0 KSP Residual norm 4.399424360499e+00 > > > > > 1 KSP Residual norm 1.614362118182e-13 > > > > > Line search: gnorm after quadratic fit 1.913552832643e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.559719302467e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm 1.499985374733e+02 lambda=1.7102027220313589e-02 > > > > > 13 SNES Function norm 1.499985374733e+02 > > > > > 0 KSP Residual norm 3.740397849742e+00 > > > > > 1 KSP Residual norm 8.986775577006e-13 > > > > > Line search: gnorm after quadratic fit 1.764118876632e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.522381536119e+02 lambda=4.8196830215713270e-02 > > > > > Line search: Cubically determined step, current gnorm 1.486175880390e+02 lambda=1.8881300948189364e-02 > > > > > 14 SNES Function norm 1.486175880390e+02 > > > > > 0 KSP Residual norm 6.067973818528e+00 > > > > > 1 KSP Residual norm 4.527845229549e-13 > > > > > Line search: gnorm after quadratic fit 2.514021299115e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.679972156573e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm 1.481015724304e+02 lambda=9.0116621678703428e-03 > > > > > 15 SNES Function norm 1.481015724304e+02 > > > > > 0 KSP Residual norm 6.108754994263e+00 > > > > > 1 KSP Residual norm 2.557635976440e-13 > > > > > Line search: gnorm after quadratic fit 2.458081150104e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.681837029397e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm 1.476148340442e+02 lambda=7.9580911933571953e-03 > > > > > 16 SNES Function norm 1.476148340442e+02 > > > > > 0 KSP Residual norm 7.914946163932e+00 > > > > > 1 KSP Residual norm 1.512066885699e-13 > > > > > Line search: gnorm after quadratic fit 3.458938604598e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.883018868359e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm 1.474286108114e+02 lambda=6.7262521208543979e-03 > > > > > 17 SNES Function norm 1.474286108114e+02 > > > > > 0 KSP Residual norm 5.285449532689e+00 > > > > > 1 KSP Residual norm 6.693733977456e-12 > > > > > Line search: gnorm after quadratic fit 2.170263102661e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.607560548008e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm 1.467785507822e+02 lambda=9.9244383205188240e-03 > > > > > 18 SNES Function norm 1.467785507822e+02 > > > > > 0 KSP Residual norm 8.124903695635e+00 > > > > > 1 KSP Residual norm 2.322439601127e-11 > > > > > Line search: gnorm after quadratic fit 3.589716592364e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.907315184877e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm 1.466341888638e+02 lambda=6.5538271222582893e-03 > > > > > 19 SNES Function norm 1.466341888638e+02 > > > > > 0 KSP Residual norm 5.253550718343e+00 > > > > > 1 KSP Residual norm 1.575657996883e-12 > > > > > Line search: gnorm after quadratic fit 2.155795776725e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.598564001687e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm 1.459869404602e+02 lambda=9.9195822632931301e-03 > > > > > 20 SNES Function norm 1.459869404602e+02 > > > > > 0 KSP Residual norm 8.405987790193e+00 > > > > > 1 KSP Residual norm 2.046159481178e-13 > > > > > Line search: gnorm after quadratic fit 3.767908298426e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.941885062002e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm 1.458995232755e+02 lambda=6.4359684554015136e-03 > > > > > 21 SNES Function norm 1.458995232755e+02 > > > > > 0 KSP Residual norm 5.036348246593e+00 > > > > > 1 KSP Residual norm 3.645081669075e-13 > > > > > Line search: gnorm after quadratic fit 2.083222977519e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.575737508694e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm 1.452039802458e+02 lambda=1.0554092389542354e-02 > > > > > 22 SNES Function norm 1.452039802458e+02 > > > > > 0 KSP Residual norm 8.562292355998e+00 > > > > > 1 KSP Residual norm 3.256332645483e-13 > > > > > Line search: gnorm after quadratic fit 3.869470823355e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.959483128249e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm 1.451523830598e+02 lambda=6.3780526507799607e-03 > > > > > 23 SNES Function norm 1.451523830598e+02 > > > > > 0 KSP Residual norm 4.919667503862e+00 > > > > > 1 KSP Residual norm 4.823931177115e-13 > > > > > Line search: gnorm after quadratic fit 2.042891039525e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.560623102934e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm 1.444331916523e+02 lambda=1.0890355421223689e-02 > > > > > 24 SNES Function norm 1.444331916523e+02 > > > > > 0 KSP Residual norm 8.727282395369e+00 > > > > > 1 KSP Residual norm 7.090683582186e-13 > > > > > Line search: gnorm after quadratic fit 3.977929422821e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.978556223200e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm 1.444215965394e+02 lambda=6.3477766966048947e-03 > > > > > 25 SNES Function norm 1.444215965394e+02 > > > > > 0 KSP Residual norm 4.759732971179e+00 > > > > > 1 KSP Residual norm 7.539889498211e-13 > > > > > Line search: gnorm after quadratic fit 1.990589649135e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.542648241555e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm 1.436629416941e+02 lambda=1.1434720389464151e-02 > > > > > 26 SNES Function norm 1.436629416941e+02 > > > > > 0 KSP Residual norm 8.844861828477e+00 > > > > > 1 KSP Residual norm 4.372001279689e-13 > > > > > Line search: gnorm after quadratic fit 4.055598972133e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.990820671396e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.436827663113e+02 lambda=6.3302081701296859e-03 > > > > > Line search: Cubically determined step, current gnorm 1.434397789472e+02 lambda=3.1285674619640730e-03 > > > > > 27 SNES Function norm 1.434397789472e+02 > > > > > 0 KSP Residual norm 2.168630760128e+01 > > > > > 1 KSP Residual norm 3.975838928402e-13 > > > > > Line search: gnorm after quadratic fit 1.655681371309e+03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.972331169594e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.804118272840e+02 lambda=1.6710557456633125e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.435928635079e+02 lambda=1.6710557456633126e-03 > > > > > Line search: Cubically determined step, current gnorm 1.434032742903e+02 lambda=5.1357350159978810e-04 > > > > > 28 SNES Function norm 1.434032742903e+02 > > > > > 0 KSP Residual norm 5.259508821923e+01 > > > > > 1 KSP Residual norm 1.358381204928e-11 > > > > > Line search: gnorm after quadratic fit 1.908330224731e+04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.431279702545e+03 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.060945045253e+02 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.791318323447e+02 lambda=1.2124172979783788e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.491140019897e+02 lambda=2.6952165802905347e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434246250245e+02 lambda=2.6952165802905350e-04 > > > > > Line search: Cubically determined step, current gnorm 1.433970449422e+02 lambda=8.6980371578986910e-05 > > > > > 29 SNES Function norm 1.433970449422e+02 > > > > > 0 KSP Residual norm 1.326287161615e+02 > > > > > 1 KSP Residual norm 5.692176796134e-12 > > > > > Line search: gnorm after quadratic fit 2.077891749832e+05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.654187989332e+04 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.213029457851e+03 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.001385334742e+03 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.323976827250e+02 lambda=5.9607661619885998e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.489839529892e+02 lambda=1.0476257410701045e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434396736634e+02 lambda=1.0476257410701046e-04 > > > > > Line search: Cubically determined step, current gnorm 1.433960671821e+02 lambda=1.3664867646895530e-05 > > > > > 30 SNES Function norm 1.433960671821e+02 > > > > > 0 KSP Residual norm 3.320710360189e+02 > > > > > 1 KSP Residual norm 1.365660123102e-11 > > > > > Line search: gnorm after quadratic fit 3.597335441013e+06 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.714766420450e+05 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.566809766217e+04 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.038660363150e+04 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.026997416957e+03 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.382653551072e+02 lambda=3.1250000000000002e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.071747386385e+02 lambda=1.3384948046761360e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.439693866777e+02 lambda=1.3384948046761360e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434000505249e+02 lambda=1.3384948046761361e-05 > > > > > Line search: Cubically determined step, current gnorm 1.433959111179e+02 lambda=2.1771867000079373e-06 > > > > > 31 SNES Function norm 1.433959111179e+02 > > > > > 0 KSP Residual norm 8.385024273664e+02 > > > > > 1 KSP Residual norm 2.688330817732e-11 > > > > > Line search: gnorm after quadratic fit 5.487352481970e+07 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.776642694838e+06 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.310551423141e+05 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.023322644608e+05 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.368662233379e+04 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.472194884015e+03 lambda=3.1250000000000002e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.718801059897e+02 lambda=1.5625000000000001e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.274234972424e+02 lambda=6.3064412238487922e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.442194384053e+02 lambda=6.3064412238487925e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434033578642e+02 lambda=6.3064412238487927e-06 > > > > > Line search: Cubically determined step, current gnorm 1.433959042208e+02 lambda=6.3064412238487929e-07 > > > > > 32 SNES Function norm 1.433959042208e+02 > > > > > 0 KSP Residual norm 5.310191626867e+02 > > > > > 1 KSP Residual norm 2.270033897601e-10 > > > > > Line search: gnorm after quadratic fit 1.447633783740e+07 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.859761774309e+06 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.472992503503e+05 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.557594026810e+04 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.969012939380e+03 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.269212161982e+03 lambda=3.1250000000000002e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.859005100842e+02 lambda=1.5625000000000001e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.695095262046e+02 lambda=5.4509037994531233e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.436389958907e+02 lambda=5.4509037994531237e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433976258223e+02 lambda=5.4509037994531242e-06 > > > > > Line search: Cubically determined step, current gnorm 1.433958431980e+02 lambda=8.5124820362933632e-07 > > > > > 33 SNES Function norm 1.433958431980e+02 > > > > > 0 KSP Residual norm 1.341142541825e+03 > > > > > 1 KSP Residual norm 4.194815344365e-11 > > > > > Line search: gnorm after quadratic fit 2.256410317099e+08 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.797696259877e+07 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.447237377751e+06 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.221898175722e+05 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.260244723327e+04 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.539148524881e+03 lambda=3.1250000000000002e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.558034531173e+03 lambda=1.5625000000000001e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.788188892302e+02 lambda=7.8125000000000004e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.753621043454e+02 lambda=2.4427125599600652e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.437122397600e+02 lambda=2.4427125599600654e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433986985128e+02 lambda=2.4427125599600655e-06 > > > > > Line search: Cubically determined step, current gnorm 1.433958402293e+02 lambda=2.4427125599600656e-07 > > > > > 34 SNES Function norm 1.433958402293e+02 > > > > > 0 KSP Residual norm 8.620962950418e+02 > > > > > 1 KSP Residual norm 4.517777375659e-11 > > > > > Line search: gnorm after quadratic fit 6.134442313460e+07 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.790495969255e+06 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.008365220843e+06 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.364572513478e+05 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.037891335918e+04 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.640571521199e+03 lambda=3.1250000000000002e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.472549649319e+02 lambda=1.5625000000000001e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.906041216274e+02 lambda=7.6348458761785112e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.504925859329e+02 lambda=1.7740973415567094e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434632637071e+02 lambda=1.7740973415567094e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433962847027e+02 lambda=1.7740973415567095e-06 > > > > > Line search: Cubically determined step, current gnorm 1.433958170795e+02 lambda=3.2293255704969003e-07 > > > > > 35 SNES Function norm 1.433958170795e+02 > > > > > 0 KSP Residual norm 2.177497039945e+03 > > > > > 1 KSP Residual norm 8.546235181505e-11 > > > > > Line search: gnorm after quadratic fit 9.689178330938e+08 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.204850731541e+08 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.491460480376e+07 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.833699292784e+06 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.246639021599e+05 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.860166571872e+04 lambda=3.1250000000000002e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.484329051490e+03 lambda=1.5625000000000001e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.050411687443e+03 lambda=7.8125000000000004e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.488366972009e+02 lambda=3.7767265396089055e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.508326035050e+02 lambda=7.2725649346261757e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434696063559e+02 lambda=7.2725649346261764e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433964618996e+02 lambda=7.2725649346261768e-07 > > > > > Line search: Cubically determined step, current gnorm 1.433958141405e+02 lambda=7.2725649346261771e-08 > > > > > 36 SNES Function norm 1.433958141405e+02 > > > > > 0 KSP Residual norm 2.164813477994e+03 > > > > > 1 KSP Residual norm 1.148881458292e-10 > > > > > Line search: gnorm after quadratic fit 9.626940870744e+08 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.210459267934e+08 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.531855101756e+07 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.966826097072e+06 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.611808255272e+05 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.746062783262e+04 lambda=3.1250000000000002e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.252259871244e+03 lambda=1.5625000000000001e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.319447372021e+03 lambda=7.8125000000000004e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.963055448218e+02 lambda=3.9062500000000002e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.719034797105e+02 lambda=1.3935000445038475e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.436664111092e+02 lambda=1.3935000445038476e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433983336239e+02 lambda=1.3935000445038476e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958213497e+02 lambda=1.3935000445038476e-07 > > > > > Line search: Cubically determined step, current gnorm 1.433958104705e+02 lambda=5.1202466521517630e-08 > > > > > 37 SNES Function norm 1.433958104705e+02 > > > > > 0 KSP Residual norm 5.470482746849e+03 > > > > > 1 KSP Residual norm 2.077456833170e-10 > > > > > Line search: gnorm after quadratic fit 1.541335606193e+10 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.922526157954e+09 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.393079394383e+08 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.967573549050e+07 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.657319925168e+06 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.479516204895e+05 lambda=3.1250000000000002e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.573399122917e+04 lambda=1.5625000000000001e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.931177424479e+03 lambda=7.8125000000000004e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.619710606187e+03 lambda=3.9062500000000002e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.924551713717e+02 lambda=1.9531250000000001e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.786095404459e+02 lambda=6.2808469554243522e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.437467476469e+02 lambda=6.2808469554243527e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433992463439e+02 lambda=6.2808469554243527e-07 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958367271e+02 lambda=6.2808469554243525e-08 > > > > > Line search: Cubically determined step, current gnorm 1.433958098948e+02 lambda=8.0208105170108588e-09 > > > > > 38 SNES Function norm 1.433958098948e+02 > > > > > 0 KSP Residual norm 1.380568582849e+04 > > > > > 1 KSP Residual norm 3.830866223513e-10 > > > > > Line search: gnorm after quadratic fit 2.484973518314e+11 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.108953896984e+10 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.893104137528e+09 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.884003910853e+08 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.150765563542e+07 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.811161146103e+06 lambda=3.1250000000000002e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.011017986781e+06 lambda=1.5625000000000001e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.368084343451e+05 lambda=7.8125000000000004e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.042876665700e+04 lambda=3.9062500000000002e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.648735196752e+03 lambda=1.9531250000000001e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.489051252413e+02 lambda=9.7656250000000005e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.910677756717e+02 lambda=4.7728537787817724e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.505452645186e+02 lambda=1.1099980464343249e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434658984864e+02 lambda=1.1099980464343249e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433964956476e+02 lambda=1.1099980464343249e-07 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958153212e+02 lambda=1.1099980464343250e-08 > > > > > Line search: Cubically determined step, current gnorm 1.433958098048e+02 lambda=1.2587012037197021e-09 > > > > > 39 SNES Function norm 1.433958098048e+02 > > > > > 0 KSP Residual norm 3.492284741552e+04 > > > > > 1 KSP Residual norm 2.459788921244e-09 > > > > > Line search: gnorm after quadratic fit 4.017424324975e+12 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.020053801097e+11 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.270768402853e+10 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.827801904036e+09 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.758550488105e+08 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.213492627852e+08 lambda=3.1250000000000002e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.502191365805e+07 lambda=1.5625000000000001e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.846947104704e+06 lambda=7.8125000000000004e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.262850216093e+05 lambda=3.9062500000000002e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.879926646684e+04 lambda=1.9531250000000001e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.510203332079e+03 lambda=9.7656250000000005e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.055028679619e+03 lambda=4.8828125000000003e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.503903269554e+02 lambda=2.3633949212111800e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.510245991472e+02 lambda=4.5897967908360529e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434724062782e+02 lambda=4.5897967908360533e-07 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433965706606e+02 lambda=4.5897967908360533e-08 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958168196e+02 lambda=4.5897967908360538e-09 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958098155e+02 lambda=4.5897967908360540e-10 > > > > > Line search: Cubically determined step, current gnorm 1.433958097906e+02 lambda=1.9745369723997599e-10 > > > > > 40 SNES Function norm 1.433958097906e+02 > > > > > 0 KSP Residual norm 8.722495521587e+04 > > > > > 1 KSP Residual norm 3.742695919275e-09 > > > > > Line search: gnorm after quadratic fit 6.262538457180e+13 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.829256308992e+12 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.789282877890e+11 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.224340679566e+11 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.532137613500e+10 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.919506047737e+09 lambda=3.1250000000000002e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.410488718338e+08 lambda=1.5625000000000001e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.042211373104e+07 lambda=7.8125000000000004e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.881986305609e+06 lambda=3.9062500000000002e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.080857001861e+05 lambda=1.9531250000000001e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.054449734307e+04 lambda=9.7656250000000005e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.109051581397e+04 lambda=4.8828125000000003e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.144985497099e+03 lambda=2.4414062500000001e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.617627947761e+02 lambda=1.2207031250000001e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.132828960986e+02 lambda=5.3137869181552773e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.440403409760e+02 lambda=5.3137869181552777e-07 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434022226216e+02 lambda=5.3137869181552781e-08 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958732177e+02 lambda=5.3137869181552781e-09 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958103569e+02 lambda=5.3137869181552779e-10 > > > > > Line search: Cubically determined step, current gnorm 1.433958097894e+02 lambda=5.3137869181552781e-11 > > > > > 41 SNES Function norm 1.433958097894e+02 > > > > > 0 KSP Residual norm 6.453169081212e+04 > > > > > 1 KSP Residual norm 2.762540688686e-09 > > > > > Line search: gnorm after quadratic fit 2.535166112592e+13 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.168366990040e+12 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.958985371462e+11 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.945064622488e+10 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.172244865713e+09 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.693002384290e+08 lambda=3.1250000000000002e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.562568994785e+07 lambda=1.5625000000000001e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.182957296890e+07 lambda=7.8125000000000004e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.453260254263e+06 lambda=3.9062500000000002e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.781984147743e+05 lambda=1.9531250000000001e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.294934468515e+04 lambda=9.7656250000000005e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.740461720782e+03 lambda=4.8828125000000003e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.162621855154e+02 lambda=2.4414062500000001e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.042417294890e+02 lambda=1.1290474210136388e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.458920680477e+02 lambda=1.4201366604660443e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434208620254e+02 lambda=1.4201366604660444e-07 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433960586269e+02 lambda=1.4201366604660445e-08 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958120934e+02 lambda=1.4201366604660445e-09 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958097940e+02 lambda=1.4201366604660446e-10 > > > > > Line search: Cubically determined step, current gnorm 1.433958097852e+02 lambda=5.7981795207229486e-11 > > > > > 42 SNES Function norm 1.433958097852e+02 > > > > > 0 KSP Residual norm 1.596625793747e+05 > > > > > 1 KSP Residual norm 6.465899717071e-09 > > > > > Line search: gnorm after quadratic fit 3.840699863976e+14 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.801237514773e+13 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.002454410823e+12 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.505340831651e+11 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.387378188418e+10 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.174857842415e+10 lambda=3.1250000000000002e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.472211181784e+09 lambda=1.5625000000000001e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.849608933788e+08 lambda=7.8125000000000004e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.336592011613e+07 lambda=3.9062500000000002e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.988079805895e+06 lambda=1.9531250000000001e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.930858080425e+05 lambda=9.7656250000000005e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.521190722497e+04 lambda=4.8828125000000003e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.872153015323e+03 lambda=2.4414062500000001e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.772337662956e+03 lambda=1.2207031250000001e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.879470852054e+02 lambda=6.1035156250000003e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.942774855488e+02 lambda=2.4957912736226801e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.438719078958e+02 lambda=2.4957912736226800e-07 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434005516391e+02 lambda=2.4957912736226800e-08 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958568732e+02 lambda=2.4957912736226803e-09 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958102244e+02 lambda=2.4957912736226804e-10 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958097865e+02 lambda=2.4957912736226805e-11 > > > > > Line search: Cubically determined step, current gnorm 1.433958097846e+02 lambda=9.2900433293108317e-12 > > > > > 43 SNES Function norm 1.433958097846e+02 > > > > > 0 KSP Residual norm 4.230869747157e+05 > > > > > 1 KSP Residual norm 2.238707423027e-08 > > > > > Line search: gnorm after quadratic fit 7.145700515048e+15 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.931871281700e+14 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.116420341041e+14 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.395366610168e+13 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.743811756566e+12 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.178776103292e+11 lambda=3.1250000000000002e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.721012032848e+10 lambda=1.5625000000000001e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.395186924428e+09 lambda=7.8125000000000004e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.229125978585e+08 lambda=3.9062500000000002e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.250971135953e+07 lambda=1.9531250000000001e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.483856203094e+06 lambda=9.7656250000000005e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.950671355228e+05 lambda=4.8828125000000003e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.795408218555e+04 lambda=2.4414062500000001e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.315025696280e+04 lambda=1.2207031250000001e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.395961070555e+03 lambda=6.1035156250000003e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.565070307576e+02 lambda=3.0517578125000002e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.228949713871e+02 lambda=1.2154989071946628e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.441831998014e+02 lambda=1.2154989071946629e-07 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434037055996e+02 lambda=1.2154989071946630e-08 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958886074e+02 lambda=1.2154989071946630e-09 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958105564e+02 lambda=1.2154989071946630e-10 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958097907e+02 lambda=1.2154989071946631e-11 > > > > > Line search: Cubically determined step, current gnorm 1.433958097845e+02 lambda=1.3559489351735629e-12 > > > > > 44 SNES Function norm 1.433958097845e+02 > > > > > 0 KSP Residual norm 1.017589039922e+06 > > > > > 1 KSP Residual norm 5.483283808994e-08 > > > > > Line search: gnorm after quadratic fit 9.942386816509e+16 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.242813073279e+16 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.553553149772e+15 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.942033483320e+14 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.427772097758e+13 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.035291372732e+12 lambda=3.1250000000000002e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.795558047824e+11 lambda=1.5625000000000001e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.748073147307e+10 lambda=7.8125000000000004e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.944235240368e+09 lambda=3.9062500000000002e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.453550734860e+08 lambda=1.9531250000000001e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.377045707707e+07 lambda=9.7656250000000005e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.188119937132e+07 lambda=4.8828125000000003e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.529730353136e+06 lambda=2.4414062500000001e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.044646611329e+05 lambda=1.2207031250000001e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.974477616118e+04 lambda=6.1035156250000003e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.087923877078e+03 lambda=3.0517578125000002e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.112257173311e+03 lambda=1.5258789062500001e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.536190077033e+02 lambda=7.6293945312500004e-07 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.622567424729e+02 lambda=2.4244966960965791e-07 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.435780438142e+02 lambda=2.4244966960965793e-08 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433976282603e+02 lambda=2.4244966960965796e-09 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958279382e+02 lambda=2.4244966960965797e-10 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958099632e+02 lambda=2.4244966960965799e-11 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958097860e+02 lambda=2.4244966960965801e-12 > > > > > Line search: Cubically determined step, current gnorm 1.433958097845e+02 lambda=2.4244966960965801e-13 > > > > > 45 SNES Function norm 1.433958097845e+02 > > > > > 0 KSP Residual norm 2.206687220910e+06 > > > > > 1 KSP Residual norm 4.897651438902e-08 > > > > > Line search: gnorm after quadratic fit 1.013883843512e+18 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.267347883019e+17 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.584167551460e+16 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.980166189110e+15 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.475099638694e+14 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.093604443378e+13 lambda=3.1250000000000002e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.866330988164e+12 lambda=1.5625000000000001e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.831230804145e+11 lambda=7.8125000000000004e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.034848618023e+10 lambda=3.9062500000000002e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.533173457427e+09 lambda=1.9531250000000001e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.390937545910e+08 lambda=9.7656250000000005e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.167706366282e+08 lambda=4.8828125000000003e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.445357932595e+07 lambda=2.4414062500000001e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.776833600920e+06 lambda=1.2207031250000001e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.177171496134e+05 lambda=6.1035156250000003e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.775750596740e+04 lambda=3.0517578125000002e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.374283858049e+03 lambda=1.5258789062500001e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.030949543491e+03 lambda=7.6293945312500004e-07 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.423064811256e+02 lambda=3.6673216108643130e-07 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.499924205417e+02 lambda=6.7541706529544844e-08 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.434620968378e+02 lambda=6.7541706529544851e-09 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433964732224e+02 lambda=6.7541706529544853e-10 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958164087e+02 lambda=6.7541706529544856e-11 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958098496e+02 lambda=6.7541706529544860e-12 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.433958097850e+02 lambda=6.7541706529544869e-13 > > > > > Line search: unable to find good step length! After 24 tries > > > > > Line search: fnorm=1.4339580978447020e+02, gnorm=1.4339580978501337e+02, ynorm=2.2066872446260620e+06, minlambda=9.9999999999999998e-13, lambda=6.7541706529544869e-13, initial slope=-2.0562359199040133e+04 > > > > > 0 SNES Function norm 7.494832241120e+03 > > > > > 0 KSP Residual norm 2.096735360816e+01 > > > > > 1 KSP Residual norm 1.310027756820e-12 > > > > > Line search: gnorm after quadratic fit 6.728375857515e+03 > > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > > 1 SNES Function norm 6.728375857515e+03 > > > > > 0 KSP Residual norm 2.051806116405e+01 > > > > > 1 KSP Residual norm 4.624620138831e-13 > > > > > Line search: gnorm after quadratic fit 6.028616261650e+03 > > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > > 2 SNES Function norm 6.028616261650e+03 > > > > > 0 KSP Residual norm 2.416503160016e+01 > > > > > 1 KSP Residual norm 8.456041680630e-13 > > > > > Line search: gnorm after quadratic fit 5.407473517447e+03 > > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > > 3 SNES Function norm 5.407473517447e+03 > > > > > 0 KSP Residual norm 1.429873750399e+01 > > > > > 1 KSP Residual norm 2.956316145819e-13 > > > > > Line search: Using full step: fnorm 5.407473517447e+03 gnorm 1.894530516076e+03 > > > > > 4 SNES Function norm 1.894530516076e+03 > > > > > 0 KSP Residual norm 2.898580554597e+00 > > > > > 1 KSP Residual norm 6.622560162623e-14 > > > > > Line search: Using full step: fnorm 1.894530516076e+03 gnorm 1.794029421846e+03 > > > > > 5 SNES Function norm 1.794029421846e+03 > > > > > 0 KSP Residual norm 1.749678611959e+01 > > > > > 1 KSP Residual norm 8.138905825078e-12 > > > > > Line search: gnorm after quadratic fit 1.767361408940e+03 > > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > > 6 SNES Function norm 1.767361408940e+03 > > > > > 0 KSP Residual norm 1.094404109423e+02 > > > > > 1 KSP Residual norm 7.696691527700e-12 > > > > > Line search: gnorm after quadratic fit 3.545750923895e+04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.153479540314e+03 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.205683629874e+03 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.802976525485e+03 lambda=1.2441094586006883e-02 > > > > > Line search: Cubically determined step, current gnorm 1.765063299263e+03 lambda=4.9240328094708914e-03 > > > > > 7 SNES Function norm 1.765063299263e+03 > > > > > 0 KSP Residual norm 1.778095975189e+01 > > > > > 1 KSP Residual norm 2.814661813934e-12 > > > > > Line search: gnorm after quadratic fit 2.620761680117e+03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.793045753271e+03 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm 1.740299227935e+03 lambda=2.5000000000000001e-02 > > > > > 8 SNES Function norm 1.740299227935e+03 > > > > > 0 KSP Residual norm 3.284236894535e+02 > > > > > 1 KSP Residual norm 5.172103783952e-10 > > > > > Line search: gnorm after quadratic fit 2.857820523902e+05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.063993491139e+04 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.588139591650e+03 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.491163684413e+03 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.802614760566e+03 lambda=5.7977212395253904e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.741444490992e+03 lambda=1.8448315876950813e-03 > > > > > Line search: Cubically determined step, current gnorm 1.739663656043e+03 lambda=7.7468345598227730e-04 > > > > > 9 SNES Function norm 1.739663656043e+03 > > > > > 0 KSP Residual norm 4.581839103558e+02 > > > > > 1 KSP Residual norm 2.627035885943e-11 > > > > > Line search: gnorm after quadratic fit 8.199478499066e+05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.127270076812e+05 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.816774161281e+04 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.053723877333e+03 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.971814513392e+03 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.755066208174e+03 lambda=2.7232010924558834e-03 > > > > > Line search: Cubically determined step, current gnorm 1.739559834479e+03 lambda=8.1458417855297680e-04 > > > > > 10 SNES Function norm 1.739559834479e+03 > > > > > 0 KSP Residual norm 1.463056810139e+02 > > > > > 1 KSP Residual norm 5.383584598825e-12 > > > > > Line search: gnorm after quadratic fit 2.885699620595e+04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.847717401708e+03 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.244464170034e+03 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.769157604338e+03 lambda=1.0857209099577540e-02 > > > > > Line search: Cubically determined step, current gnorm 1.737356225452e+03 lambda=4.0312937622950231e-03 > > > > > 11 SNES Function norm 1.737356225452e+03 > > > > > 0 KSP Residual norm 1.564105677925e+02 > > > > > 1 KSP Residual norm 6.671164745832e-11 > > > > > Line search: gnorm after quadratic fit 3.815800291873e+04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.197027796134e+03 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.373151605545e+03 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.783976520867e+03 lambda=1.2093374970461970e-02 > > > > > Line search: Cubically determined step, current gnorm 1.735737929915e+03 lambda=4.9529698477569920e-03 > > > > > 12 SNES Function norm 1.735737929915e+03 > > > > > 0 KSP Residual norm 5.030757139645e+01 > > > > > 1 KSP Residual norm 1.157542730692e-12 > > > > > Line search: gnorm after quadratic fit 3.004544441458e+03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.850403239750e+03 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm 1.722893188305e+03 lambda=2.0881992439921702e-02 > > > > > 13 SNES Function norm 1.722893188305e+03 > > > > > 0 KSP Residual norm 7.123428853845e+01 > > > > > 1 KSP Residual norm 8.671726774894e-12 > > > > > Line search: gnorm after quadratic fit 4.361041499279e+03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.032697222107e+03 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.726212330814e+03 lambda=1.9909470348267504e-02 > > > > > Line search: Cubically determined step, current gnorm 1.714127356920e+03 lambda=9.9547351741337518e-03 > > > > > 14 SNES Function norm 1.714127356920e+03 > > > > > 0 KSP Residual norm 8.304557447257e+00 > > > > > 1 KSP Residual norm 6.268295862688e-13 > > > > > Line search: gnorm after quadratic fit 1.558163002487e+03 > > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > > 15 SNES Function norm 1.558163002487e+03 > > > > > 0 KSP Residual norm 2.820803287164e+00 > > > > > 1 KSP Residual norm 5.477413853752e-13 > > > > > Line search: gnorm after quadratic fit 1.065673478530e+03 > > > > > Line search: Quadratically determined step, lambda=3.8943438938591052e-01 > > > > > 16 SNES Function norm 1.065673478530e+03 > > > > > 0 KSP Residual norm 2.296739120664e+00 > > > > > 1 KSP Residual norm 6.273731899885e-14 > > > > > Line search: gnorm after quadratic fit 8.964342150621e+02 > > > > > Line search: Quadratically determined step, lambda=1.8740736900935545e-01 > > > > > 17 SNES Function norm 8.964342150621e+02 > > > > > 0 KSP Residual norm 5.567568505830e+00 > > > > > 1 KSP Residual norm 8.649083600764e-12 > > > > > Line search: gnorm after quadratic fit 8.322514858992e+02 > > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > > 18 SNES Function norm 8.322514858992e+02 > > > > > 0 KSP Residual norm 1.164393577210e+00 > > > > > 1 KSP Residual norm 2.019248309015e-14 > > > > > Line search: Using full step: fnorm 8.322514858992e+02 gnorm 3.179750274746e+02 > > > > > 19 SNES Function norm 3.179750274746e+02 > > > > > 0 KSP Residual norm 5.339294310641e+00 > > > > > 1 KSP Residual norm 2.070321587238e-13 > > > > > Line search: gnorm after quadratic fit 3.433012316833e+02 > > > > > Line search: Cubically determined step, current gnorm 3.140305403821e+02 lambda=5.0000000000000003e-02 > > > > > 20 SNES Function norm 3.140305403821e+02 > > > > > 0 KSP Residual norm 1.177016565578e+01 > > > > > 1 KSP Residual norm 2.413027540446e-13 > > > > > Line search: gnorm after quadratic fit 7.377851778409e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.896721016582e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm 3.136619309181e+02 lambda=9.7219892278716195e-03 > > > > > 21 SNES Function norm 3.136619309181e+02 > > > > > 0 KSP Residual norm 3.973565083977e+00 > > > > > 1 KSP Residual norm 9.726786674410e-14 > > > > > Line search: gnorm after quadratic fit 3.098277326090e+02 > > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > > 22 SNES Function norm 3.098277326090e+02 > > > > > 0 KSP Residual norm 9.389290683519e+00 > > > > > 1 KSP Residual norm 1.651497163724e-13 > > > > > Line search: gnorm after quadratic fit 6.887970540455e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.588146381477e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.099274823603e+02 lambda=1.6890426151283184e-02 > > > > > Line search: Cubically determined step, current gnorm 3.084890760827e+02 lambda=8.4452130756415920e-03 > > > > > 23 SNES Function norm 3.084890760827e+02 > > > > > 0 KSP Residual norm 2.381130479641e+00 > > > > > 1 KSP Residual norm 4.694489283156e-14 > > > > > Line search: gnorm after quadratic fit 2.872151876535e+02 > > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > > 24 SNES Function norm 2.872151876535e+02 > > > > > 0 KSP Residual norm 2.405498502269e+00 > > > > > 1 KSP Residual norm 3.316846070538e-13 > > > > > Line search: gnorm after quadratic fit 2.686789761232e+02 > > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > > 25 SNES Function norm 2.686789761232e+02 > > > > > 0 KSP Residual norm 1.728772970554e+00 > > > > > 1 KSP Residual norm 4.132974383339e-14 > > > > > Line search: gnorm after quadratic fit 2.365009918229e+02 > > > > > Line search: Quadratically determined step, lambda=1.7273357529379074e-01 > > > > > 26 SNES Function norm 2.365009918229e+02 > > > > > 0 KSP Residual norm 4.413764759374e+00 > > > > > 1 KSP Residual norm 5.210690816917e-14 > > > > > Line search: gnorm after quadratic fit 2.756730968257e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.372321757171e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm 2.335020811250e+02 lambda=2.5000000000000001e-02 > > > > > 27 SNES Function norm 2.335020811250e+02 > > > > > 0 KSP Residual norm 1.606246507553e+00 > > > > > 1 KSP Residual norm 3.564847846678e-14 > > > > > Line search: gnorm after quadratic fit 2.078263630653e+02 > > > > > Line search: Quadratically determined step, lambda=1.5913860995949433e-01 > > > > > 28 SNES Function norm 2.078263630653e+02 > > > > > 0 KSP Residual norm 3.700632954873e+00 > > > > > 1 KSP Residual norm 5.113863400264e-13 > > > > > Line search: gnorm after quadratic fit 2.142503514807e+02 > > > > > Line search: Cubically determined step, current gnorm 2.021095009118e+02 lambda=5.0000000000000003e-02 > > > > > 29 SNES Function norm 2.021095009118e+02 > > > > > 0 KSP Residual norm 3.056449560135e+00 > > > > > 1 KSP Residual norm 3.207987681334e-14 > > > > > Line search: gnorm after quadratic fit 2.064252530802e+02 > > > > > Line search: Cubically determined step, current gnorm 1.978069081639e+02 lambda=5.0000000000000003e-02 > > > > > 30 SNES Function norm 1.978069081639e+02 > > > > > 0 KSP Residual norm 2.024695620703e+00 > > > > > 1 KSP Residual norm 5.460360737995e-14 > > > > > Line search: gnorm after quadratic fit 1.839556530796e+02 > > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > > 31 SNES Function norm 1.839556530796e+02 > > > > > 0 KSP Residual norm 1.610676619931e+01 > > > > > 1 KSP Residual norm 6.703552136307e-13 > > > > > Line search: gnorm after quadratic fit 7.186735314913e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.905672430097e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.856766286600e+02 lambda=1.0830798014298563e-02 > > > > > Line search: Cubically determined step, current gnorm 1.836818937131e+02 lambda=3.3207362501459785e-03 > > > > > 32 SNES Function norm 1.836818937131e+02 > > > > > 0 KSP Residual norm 7.471722173131e+01 > > > > > 1 KSP Residual norm 2.671534648829e-12 > > > > > Line search: gnorm after quadratic fit 9.613379909411e+04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.509491298762e+04 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.808861367705e+03 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.767283758299e+02 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.665421328348e+02 lambda=6.0369453941238101e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.869726717041e+02 lambda=1.4394327006264963e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.836897704575e+02 lambda=1.4394327006264963e-04 > > > > > Line search: Cubically determined step, current gnorm 1.836767951408e+02 lambda=5.5567420418543164e-05 > > > > > 33 SNES Function norm 1.836767951408e+02 > > > > > 0 KSP Residual norm 2.702367712138e+01 > > > > > 1 KSP Residual norm 2.731656687850e-12 > > > > > Line search: gnorm after quadratic fit 3.331563146098e+03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.723694790688e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.941243220944e+02 lambda=2.1443568774664485e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.847231733910e+02 lambda=2.7571330376860012e-03 > > > > > Line search: Cubically determined step, current gnorm 1.836356729409e+02 lambda=4.7841280418270480e-04 > > > > > 34 SNES Function norm 1.836356729409e+02 > > > > > 0 KSP Residual norm 1.228333177997e+01 > > > > > 1 KSP Residual norm 2.681127387880e-13 > > > > > Line search: gnorm after quadratic fit 6.936329223475e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.749327218775e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.871557327742e+02 lambda=1.4160505301999991e-02 > > > > > Line search: Cubically determined step, current gnorm 1.833523080682e+02 lambda=3.5196326548579192e-03 > > > > > 35 SNES Function norm 1.833523080682e+02 > > > > > 0 KSP Residual norm 3.531886257396e+02 > > > > > 1 KSP Residual norm 2.364634092895e-11 > > > > > Line search: gnorm after quadratic fit 3.994783047929e+06 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.753715960726e+05 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.516669898185e+04 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.918985942348e+03 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.363599250418e+03 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.344906818752e+02 lambda=3.1250000000000002e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.991088183980e+02 lambda=1.0108094710462592e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.834621681844e+02 lambda=1.0108094710462593e-04 > > > > > Line search: Cubically determined step, current gnorm 1.833517377324e+02 lambda=1.0108094710462594e-05 > > > > > 36 SNES Function norm 1.833517377324e+02 > > > > > 0 KSP Residual norm 9.005833507118e+01 > > > > > 1 KSP Residual norm 6.116387880629e-12 > > > > > Line search: gnorm after quadratic fit 8.899847103226e+04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.388111536526e+04 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.532652074749e+03 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.864912734009e+02 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.421068789960e+02 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.873498120960e+02 lambda=2.1924025345283278e-03 > > > > > Line search: Cubically determined step, current gnorm 1.833506987706e+02 lambda=2.1924025345283280e-04 > > > > > 37 SNES Function norm 1.833506987706e+02 > > > > > 0 KSP Residual norm 1.548426525207e+01 > > > > > 1 KSP Residual norm 1.038038773942e-12 > > > > > Line search: gnorm after quadratic fit 6.702848665441e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.789880616078e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.846521504351e+02 lambda=1.0567302644323170e-02 > > > > > Line search: Cubically determined step, current gnorm 1.830548481815e+02 lambda=3.5274490352771972e-03 > > > > > 38 SNES Function norm 1.830548481815e+02 > > > > > 0 KSP Residual norm 1.523095478807e+01 > > > > > 1 KSP Residual norm 1.963823596119e-12 > > > > > Line search: gnorm after quadratic fit 9.255727478491e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.496757253461e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.863126241242e+02 lambda=9.3143291632966311e-03 > > > > > Line search: Cubically determined step, current gnorm 1.829091761403e+02 lambda=1.8107234819462800e-03 > > > > > 39 SNES Function norm 1.829091761403e+02 > > > > > 0 KSP Residual norm 1.311320726934e+01 > > > > > 1 KSP Residual norm 9.084170520902e-13 > > > > > Line search: gnorm after quadratic fit 7.488610069188e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.691148243365e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.885558228772e+02 lambda=1.9439894235886539e-02 > > > > > Line search: Cubically determined step, current gnorm 1.825540619134e+02 lambda=5.4967824488704169e-03 > > > > > 40 SNES Function norm 1.825540619134e+02 > > > > > 0 KSP Residual norm 1.218635557505e+01 > > > > > 1 KSP Residual norm 7.760485728617e-13 > > > > > Line search: gnorm after quadratic fit 6.636453826807e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.880828006022e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.830493790584e+02 lambda=6.6234802648049863e-03 > > > > > Line search: Cubically determined step, current gnorm 1.823397545268e+02 lambda=2.4308217464828865e-03 > > > > > 41 SNES Function norm 1.823397545268e+02 > > > > > 0 KSP Residual norm 9.456543593865e+00 > > > > > 1 KSP Residual norm 7.046593270309e-13 > > > > > Line search: gnorm after quadratic fit 3.369769163110e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.105230957789e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm 1.817897533119e+02 lambda=9.1612481372917148e-03 > > > > > 42 SNES Function norm 1.817897533119e+02 > > > > > 0 KSP Residual norm 7.290035145805e+00 > > > > > 1 KSP Residual norm 3.198962158141e-12 > > > > > Line search: gnorm after quadratic fit 2.858311567415e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.965004842981e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm 1.808845577764e+02 lambda=1.3826421990147811e-02 > > > > > 43 SNES Function norm 1.808845577764e+02 > > > > > 0 KSP Residual norm 7.256785036157e+00 > > > > > 1 KSP Residual norm 9.243179217625e-14 > > > > > Line search: gnorm after quadratic fit 2.534388176390e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.916726818893e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm 1.797953125543e+02 lambda=1.3677747819164022e-02 > > > > > 44 SNES Function norm 1.797953125543e+02 > > > > > 0 KSP Residual norm 1.716201096352e+01 > > > > > 1 KSP Residual norm 2.701418800808e-13 > > > > > Line search: gnorm after quadratic fit 1.331064301474e+03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.461842246267e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.920668830294e+02 lambda=1.2856504859057132e-02 > > > > > Line search: Cubically determined step, current gnorm 1.797121460957e+02 lambda=1.4396611381500967e-03 > > > > > 45 SNES Function norm 1.797121460957e+02 > > > > > 0 KSP Residual norm 6.613432967985e+00 > > > > > 1 KSP Residual norm 1.357752977076e-13 > > > > > Line search: gnorm after quadratic fit 2.721288927858e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.939638282615e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm 1.787985482018e+02 lambda=1.2647907914070569e-02 > > > > > 46 SNES Function norm 1.787985482018e+02 > > > > > 0 KSP Residual norm 1.225736349281e+01 > > > > > 1 KSP Residual norm 3.819378790812e-13 > > > > > Line search: gnorm after quadratic fit 4.548006065036e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.304803559060e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm 1.787344729174e+02 lambda=8.9002284237256531e-03 > > > > > 47 SNES Function norm 1.787344729174e+02 > > > > > 0 KSP Residual norm 6.302465402340e+00 > > > > > 1 KSP Residual norm 6.980931947122e-14 > > > > > Line search: gnorm after quadratic fit 2.879477700004e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.980806946742e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm 1.780128006935e+02 lambda=1.0223293444602008e-02 > > > > > 48 SNES Function norm 1.780128006935e+02 > > > > > 0 KSP Residual norm 4.323829277968e+00 > > > > > 1 KSP Residual norm 5.223881369308e-13 > > > > > Line search: gnorm after quadratic fit 1.957928151218e+02 > > > > > Line search: Cubically determined step, current gnorm 1.768899805640e+02 lambda=5.0000000000000003e-02 > > > > > 49 SNES Function norm 1.768899805640e+02 > > > > > 0 KSP Residual norm 2.249256107033e+00 > > > > > 1 KSP Residual norm 3.624400957270e-14 > > > > > Line search: gnorm after quadratic fit 1.704782114773e+02 > > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > > 50 SNES Function norm 1.704782114773e+02 > > > > > 0 SNES Function norm 3.513783397332e+03 > > > > > 0 KSP Residual norm 1.650214950648e+01 > > > > > 1 KSP Residual norm 3.574269752690e-13 > > > > > Line search: gnorm after quadratic fit 3.155830404050e+03 > > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > > 1 SNES Function norm 3.155830404050e+03 > > > > > 0 KSP Residual norm 1.443734018042e+01 > > > > > 1 KSP Residual norm 3.685565191058e-13 > > > > > Line search: Using full step: fnorm 3.155830404050e+03 gnorm 8.581212204155e+02 > > > > > 2 SNES Function norm 8.581212204155e+02 > > > > > 0 KSP Residual norm 2.492601775565e+00 > > > > > 1 KSP Residual norm 9.698440210389e-14 > > > > > Line search: Using full step: fnorm 8.581212204155e+02 gnorm 7.018609898542e+02 > > > > > 3 SNES Function norm 7.018609898542e+02 > > > > > 0 KSP Residual norm 1.740320986421e+00 > > > > > 1 KSP Residual norm 2.868780682435e-14 > > > > > Line search: Using full step: fnorm 7.018609898542e+02 gnorm 2.135824235887e+02 > > > > > 4 SNES Function norm 2.135824235887e+02 > > > > > 0 KSP Residual norm 1.647413497077e+00 > > > > > 1 KSP Residual norm 2.731226225666e-14 > > > > > Line search: gnorm after quadratic fit 1.936469032649e+02 > > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > > 5 SNES Function norm 1.936469032649e+02 > > > > > 0 KSP Residual norm 1.406615972124e+00 > > > > > 1 KSP Residual norm 3.167179626699e-14 > > > > > Line search: gnorm after quadratic fit 1.755362571467e+02 > > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > > 6 SNES Function norm 1.755362571467e+02 > > > > > 0 KSP Residual norm 1.480681706594e+00 > > > > > 1 KSP Residual norm 2.935210968935e-14 > > > > > Line search: gnorm after quadratic fit 1.597659506616e+02 > > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > > 7 SNES Function norm 1.597659506616e+02 > > > > > 0 KSP Residual norm 4.013154698097e+00 > > > > > 1 KSP Residual norm 1.021628704832e-13 > > > > > Line search: gnorm after quadratic fit 1.728408060966e+02 > > > > > Line search: Cubically determined step, current gnorm 1.570815760721e+02 lambda=5.0000000000000003e-02 > > > > > 8 SNES Function norm 1.570815760721e+02 > > > > > 0 KSP Residual norm 1.510335662636e+00 > > > > > 1 KSP Residual norm 2.728243244724e-14 > > > > > Line search: gnorm after quadratic fit 1.450162880692e+02 > > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > > 9 SNES Function norm 1.450162880692e+02 > > > > > 0 KSP Residual norm 1.923349271077e+01 > > > > > 1 KSP Residual norm 1.640711956406e-11 > > > > > Line search: gnorm after quadratic fit 1.016537223115e+03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.584263092048e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.490729346583e+02 lambda=9.3725990358703350e-03 > > > > > Line search: Cubically determined step, current gnorm 1.449349273006e+02 lambda=1.5464889706033082e-03 > > > > > 10 SNES Function norm 1.449349273006e+02 > > > > > 0 KSP Residual norm 1.154999084194e+01 > > > > > 1 KSP Residual norm 1.292167633338e-11 > > > > > Line search: gnorm after quadratic fit 6.060386918705e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.236630526035e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.491201927819e+02 lambda=1.6816056300124185e-02 > > > > > Line search: Cubically determined step, current gnorm 1.447023047013e+02 lambda=4.1484374564153808e-03 > > > > > 11 SNES Function norm 1.447023047013e+02 > > > > > 0 KSP Residual norm 7.278906180502e+00 > > > > > 1 KSP Residual norm 2.815632651924e-12 > > > > > Line search: gnorm after quadratic fit 2.512278711773e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.624350957814e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm 1.441656049510e+02 lambda=1.0879389002513012e-02 > > > > > 12 SNES Function norm 1.441656049510e+02 > > > > > 0 KSP Residual norm 4.449836480267e+00 > > > > > 1 KSP Residual norm 3.152365624813e-13 > > > > > Line search: gnorm after quadratic fit 1.749680739878e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.458763435996e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm 1.425715025152e+02 lambda=2.2766809271842225e-02 > > > > > 13 SNES Function norm 1.425715025152e+02 > > > > > 0 KSP Residual norm 4.218495037726e+00 > > > > > 1 KSP Residual norm 1.398472536142e-12 > > > > > Line search: gnorm after quadratic fit 1.645159536467e+02 > > > > > Line search: Cubically determined step, current gnorm 1.421991559212e+02 lambda=4.1883769431247941e-02 > > > > > 14 SNES Function norm 1.421991559212e+02 > > > > > 0 KSP Residual norm 1.968853538608e+00 > > > > > 1 KSP Residual norm 7.594023450519e-12 > > > > > Line search: gnorm after quadratic fit 1.350960142124e+02 > > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > > 15 SNES Function norm 1.350960142124e+02 > > > > > 0 KSP Residual norm 3.444721686085e+00 > > > > > 1 KSP Residual norm 5.312609674019e-14 > > > > > Line search: gnorm after quadratic fit 1.472880565107e+02 > > > > > Line search: Cubically determined step, current gnorm 1.336714620145e+02 lambda=4.1341550820829437e-02 > > > > > 16 SNES Function norm 1.336714620145e+02 > > > > > 0 KSP Residual norm 3.276288899397e+00 > > > > > 1 KSP Residual norm 8.394674946715e-14 > > > > > Line search: gnorm after quadratic fit 1.459274497150e+02 > > > > > Line search: Cubically determined step, current gnorm 1.327618539486e+02 lambda=5.0000000000000003e-02 > > > > > 17 SNES Function norm 1.327618539486e+02 > > > > > 0 KSP Residual norm 2.630052244303e+00 > > > > > 1 KSP Residual norm 4.351283410507e-14 > > > > > Line search: gnorm after quadratic fit 1.350378060116e+02 > > > > > Line search: Cubically determined step, current gnorm 1.299403903934e+02 lambda=4.9913529436269283e-02 > > > > > 18 SNES Function norm 1.299403903934e+02 > > > > > 0 KSP Residual norm 6.124953430138e+00 > > > > > 1 KSP Residual norm 2.295381352938e-13 > > > > > Line search: gnorm after quadratic fit 2.275621676963e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.469611730657e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm 1.294890694898e+02 lambda=1.0071939100661648e-02 > > > > > 19 SNES Function norm 1.294890694898e+02 > > > > > 0 KSP Residual norm 1.036733907011e+01 > > > > > 1 KSP Residual norm 1.800941381283e-13 > > > > > Line search: gnorm after quadratic fit 3.844879463595e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.875071148504e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm 1.294494430642e+02 lambda=5.0000000000000010e-03 > > > > > 20 SNES Function norm 1.294494430642e+02 > > > > > 0 KSP Residual norm 8.224001595443e+00 > > > > > 1 KSP Residual norm 3.337810156182e-13 > > > > > Line search: gnorm after quadratic fit 3.332325263497e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.682441841234e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.294720538860e+02 lambda=8.5401597581228530e-03 > > > > > Line search: Cubically determined step, current gnorm 1.291762382985e+02 lambda=4.2555418164960989e-03 > > > > > 21 SNES Function norm 1.291762382985e+02 > > > > > 0 KSP Residual norm 3.920749219860e+01 > > > > > 1 KSP Residual norm 1.610902886435e-12 > > > > > Line search: gnorm after quadratic fit 3.472422440640e+03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.023065712859e+03 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.228184088700e+02 lambda=1.6004598823093592e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.298607525058e+02 lambda=1.6004598823093593e-03 > > > > > Line search: Cubically determined step, current gnorm 1.291643460998e+02 lambda=1.9319076533745672e-04 > > > > > 22 SNES Function norm 1.291643460998e+02 > > > > > 0 KSP Residual norm 1.520092314848e+02 > > > > > 1 KSP Residual norm 7.089159192434e-11 > > > > > Line search: gnorm after quadratic fit 2.752539686422e+05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.237188995536e+04 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.484370498858e+03 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.571039994484e+03 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.280898858362e+02 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.708927009106e+02 lambda=2.6114913411793973e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.294919567784e+02 lambda=2.6114913411793975e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291645609810e+02 lambda=2.6114913411793977e-05 > > > > > Line search: Cubically determined step, current gnorm 1.291635530596e+02 lambda=1.2278773895355162e-05 > > > > > 23 SNES Function norm 1.291635530596e+02 > > > > > 0 KSP Residual norm 7.569206058965e+02 > > > > > 1 KSP Residual norm 3.454693729751e-11 > > > > > Line search: gnorm after quadratic fit 2.570888738395e+07 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.064965025187e+06 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.498514098182e+05 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.807487005202e+04 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.233167830543e+03 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.396736912757e+03 lambda=3.1250000000000002e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.547572543330e+02 lambda=1.2623406091699435e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.335889024473e+02 lambda=1.8542137907683829e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.292059042479e+02 lambda=1.8542137907683831e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291637618568e+02 lambda=1.8542137907683832e-06 > > > > > Line search: Cubically determined step, current gnorm 1.291635210734e+02 lambda=4.9524172913414387e-07 > > > > > 24 SNES Function norm 1.291635210734e+02 > > > > > 0 KSP Residual norm 3.761913422861e+03 > > > > > 1 KSP Residual norm 6.181718776929e-10 > > > > > Line search: gnorm after quadratic fit 3.342370445037e+09 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.218326646111e+08 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.375128803204e+07 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.980626157021e+06 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.407418671219e+05 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.357321025399e+05 lambda=3.1250000000000002e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.188948059047e+04 lambda=1.5625000000000001e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.105117929713e+03 lambda=7.8125000000000004e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.331054736818e+02 lambda=3.9062500000000002e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.942479792843e+02 lambda=1.9412500272460620e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.436944624694e+02 lambda=6.4483223307578726e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.292972287211e+02 lambda=6.4483223307578726e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291647778160e+02 lambda=6.4483223307578730e-07 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635261433e+02 lambda=6.4483223307578730e-08 > > > > > Line search: Cubically determined step, current gnorm 1.291635197798e+02 lambda=2.0042115918485846e-08 > > > > > 25 SNES Function norm 1.291635197798e+02 > > > > > 0 KSP Residual norm 1.874745766083e+04 > > > > > 1 KSP Residual norm 1.476978150334e-09 > > > > > Line search: gnorm after quadratic fit 4.089262111368e+11 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.101717203770e+10 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.352565940292e+09 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.879613196620e+08 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.698613558125e+07 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.175566265039e+07 lambda=3.1250000000000002e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.382919964952e+06 lambda=1.5625000000000001e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.545431975334e+05 lambda=7.8125000000000004e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.713561369103e+04 lambda=3.9062500000000002e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.031789308419e+03 lambda=1.9531250000000001e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.205847020738e+02 lambda=9.7656250000000005e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.957203153158e+02 lambda=2.8132879163728503e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.297923302791e+02 lambda=2.8132879163728504e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291698100579e+02 lambda=2.8132879163728504e-07 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635794525e+02 lambda=2.8132879163728506e-08 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635200489e+02 lambda=2.8132879163728508e-09 > > > > > Line search: Cubically determined step, current gnorm 1.291635197275e+02 lambda=8.0832061492461345e-10 > > > > > 26 SNES Function norm 1.291635197275e+02 > > > > > 0 KSP Residual norm 9.248381077528e+04 > > > > > 1 KSP Residual norm 7.262307068447e-09 > > > > > Line search: gnorm after quadratic fit 4.920647210624e+13 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.153216818065e+12 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.697543960375e+11 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.637004379805e+10 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.208402653149e+10 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.519988135798e+09 lambda=3.1250000000000002e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.923903214787e+08 lambda=1.5625000000000001e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.465663001976e+07 lambda=7.8125000000000004e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.238603967195e+06 lambda=3.9062500000000002e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.459179143177e+05 lambda=1.9531250000000001e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.676301042792e+04 lambda=9.7656250000000005e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.135808875752e+04 lambda=4.8828125000000003e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.275714918657e+03 lambda=2.4414062500000001e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.719037747616e+02 lambda=1.2207031250000001e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.039826156716e+02 lambda=5.5609199181402721e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.308092967809e+02 lambda=9.1057337296683134e-07 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291796742824e+02 lambda=9.1057337296683134e-08 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291636800174e+02 lambda=9.1057337296683134e-09 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635212255e+02 lambda=9.1057337296683134e-10 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635197320e+02 lambda=9.1057337296683139e-11 > > > > > Line search: Cubically determined step, current gnorm 1.291635197254e+02 lambda=3.2898162617097329e-11 > > > > > 27 SNES Function norm 1.291635197254e+02 > > > > > 0 KSP Residual norm 4.818745996826e+05 > > > > > 1 KSP Residual norm 3.300979345194e-08 > > > > > Line search: gnorm after quadratic fit 6.957046028867e+15 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.695654311477e+14 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.086793500688e+14 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.358083744813e+13 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.696584801696e+12 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.118183549773e+11 lambda=3.1250000000000002e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.641372080976e+10 lambda=1.5625000000000001e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.285878535769e+09 lambda=7.8125000000000004e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.068045470276e+08 lambda=3.9062500000000002e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.988290932539e+07 lambda=1.9531250000000001e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.001404304764e+06 lambda=9.7656250000000005e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.962234585736e+05 lambda=4.8828125000000003e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.648190078115e+04 lambda=2.4414062500000001e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.098288624714e+03 lambda=1.2207031250000001e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.025132922751e+03 lambda=6.1035156250000003e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.536770142392e+02 lambda=3.0517578125000002e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.529553964021e+02 lambda=6.6615844706846272e-07 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.293970371303e+02 lambda=6.6615844706846277e-08 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291658631829e+02 lambda=6.6615844706846284e-09 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635430890e+02 lambda=6.6615844706846284e-10 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635199508e+02 lambda=6.6615844706846284e-11 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635197268e+02 lambda=6.6615844706846284e-12 > > > > > Line search: Cubically determined step, current gnorm 1.291635197253e+02 lambda=1.2496728806533799e-12 > > > > > 28 SNES Function norm 1.291635197253e+02 > > > > > 0 KSP Residual norm 2.124622394867e+06 > > > > > 1 KSP Residual norm 2.766225333896e-07 > > > > > Line search: gnorm after quadratic fit 5.963587884154e+17 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.454611858824e+16 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.318582340500e+15 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.164902175749e+15 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.456326197371e+14 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.820904039469e+13 lambda=3.1250000000000002e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.277371273495e+12 lambda=1.5625000000000001e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.849819609184e+11 lambda=7.8125000000000004e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.570050545145e+10 lambda=3.9062500000000002e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.482064028328e+09 lambda=1.9531250000000001e-04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.651631635063e+08 lambda=9.7656250000000005e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.188623828904e+07 lambda=4.8828125000000003e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.302868645305e+06 lambda=2.4414062500000001e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.245214424313e+06 lambda=1.2207031250000001e-05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.775004618570e+05 lambda=6.1035156250000003e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.810228834086e+04 lambda=3.0517578125000002e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.148910945566e+03 lambda=1.5258789062500001e-06 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.133679879416e+03 lambda=7.6293945312500004e-07 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.382468615011e+02 lambda=3.8146972656250002e-07 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.519773483633e+02 lambda=1.4103864371136453e-07 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.293690599792e+02 lambda=1.4103864371136454e-08 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291655645282e+02 lambda=1.4103864371136455e-09 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635401518e+02 lambda=1.4103864371136456e-10 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635199283e+02 lambda=1.4103864371136456e-11 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635197272e+02 lambda=1.4103864371136456e-12 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.291635197253e+02 lambda=1.4103864371136457e-13 > > > > > Line search: unable to find good step length! After 25 tries > > > > > Line search: fnorm=1.2916351972528861e+02, gnorm=1.2916351972529532e+02, ynorm=2.1246218291095798e+06, minlambda=9.9999999999999998e-13, lambda=1.4103864371136457e-13, initial slope=-1.6683210999382733e+04 > > > > > 0 SNES Function norm 7.158176401507e+03 > > > > > 0 KSP Residual norm 7.545626598553e+02 > > > > > 1 KSP Residual norm 2.192822940623e-11 > > > > > Line search: gnorm after quadratic fit 6.003975664723e+07 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.501930637484e+06 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.380142516806e+05 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.179837352860e+05 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.656902039419e+04 lambda=6.2500000000000003e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.340091686120e+03 lambda=3.1250000000000002e-03 > > > > > Line search: Cubically determined step, current gnorm 7.127478647243e+03 lambda=1.5625000000000001e-03 > > > > > 1 SNES Function norm 7.127478647243e+03 > > > > > 0 KSP Residual norm 3.139792512249e+01 > > > > > 1 KSP Residual norm 5.765552480238e-13 > > > > > Line search: gnorm after quadratic fit 7.131728282938e+03 > > > > > Line search: Cubically determined step, current gnorm 6.730387269330e+03 lambda=5.0000000000000003e-02 > > > > > 2 SNES Function norm 6.730387269330e+03 > > > > > 0 KSP Residual norm 2.247436817553e+01 > > > > > 1 KSP Residual norm 4.129717651221e-13 > > > > > Line search: gnorm after quadratic fit 6.018304311910e+03 > > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > > 3 SNES Function norm 6.018304311910e+03 > > > > > 0 KSP Residual norm 1.605973421081e+01 > > > > > 1 KSP Residual norm 3.614891198134e-13 > > > > > Line search: gnorm after quadratic fit 5.394599276028e+03 > > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > > 4 SNES Function norm 5.394599276028e+03 > > > > > 0 KSP Residual norm 1.491002227850e+01 > > > > > 1 KSP Residual norm 5.905756964447e-13 > > > > > Line search: gnorm after quadratic fit 4.845108544722e+03 > > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > > 5 SNES Function norm 4.845108544722e+03 > > > > > 0 KSP Residual norm 1.562997766581e+02 > > > > > 1 KSP Residual norm 5.722461855805e-12 > > > > > Line search: gnorm after quadratic fit 1.663505509947e+05 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.368547472010e+04 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.067825049920e+03 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.852173464442e+03 lambda=1.2500000000000001e-02 > > > > > Line search: Cubically determined step, current gnorm 4.819549937425e+03 lambda=6.2500000000000003e-03 > > > > > 6 SNES Function norm 4.819549937425e+03 > > > > > 0 KSP Residual norm 1.652787385042e+01 > > > > > 1 KSP Residual norm 7.774483442550e-13 > > > > > Line search: gnorm after quadratic fit 2.868840270198e+03 > > > > > Line search: Quadratically determined step, lambda=3.9586658383856743e-01 > > > > > 7 SNES Function norm 2.868840270198e+03 > > > > > 0 KSP Residual norm 1.220061851091e+01 > > > > > 1 KSP Residual norm 4.785407437718e-13 > > > > > Line search: gnorm after quadratic fit 2.616720732407e+03 > > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > > 8 SNES Function norm 2.616720732407e+03 > > > > > 0 KSP Residual norm 2.884722153958e+01 > > > > > 1 KSP Residual norm 5.474553921306e-13 > > > > > Line search: gnorm after quadratic fit 3.025386805317e+03 > > > > > Line search: Cubically determined step, current gnorm 2.572110173067e+03 lambda=5.0000000000000003e-02 > > > > > 9 SNES Function norm 2.572110173067e+03 > > > > > 0 KSP Residual norm 5.239447686736e+01 > > > > > 1 KSP Residual norm 1.006906008399e-12 > > > > > Line search: gnorm after quadratic fit 5.237562098046e+03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.722529781980e+03 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm 2.553072891461e+03 lambda=2.5000000000000001e-02 > > > > > 10 SNES Function norm 2.553072891461e+03 > > > > > 0 KSP Residual norm 6.511316788880e+00 > > > > > 1 KSP Residual norm 1.340296659008e-13 > > > > > Line search: gnorm after quadratic fit 2.299704119080e+03 > > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > > 11 SNES Function norm 2.299704119080e+03 > > > > > 0 KSP Residual norm 5.268131426587e+00 > > > > > 1 KSP Residual norm 1.017563310127e-13 > > > > > Line search: Using full step: fnorm 2.299704119080e+03 gnorm 7.642690039388e+02 > > > > > 12 SNES Function norm 7.642690039388e+02 > > > > > 0 KSP Residual norm 1.467735721574e+01 > > > > > 1 KSP Residual norm 1.090242963543e-12 > > > > > Line search: gnorm after quadratic fit 1.042766084830e+03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.924803860137e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm 7.581126971182e+02 lambda=1.8508848315139208e-02 > > > > > 13 SNES Function norm 7.581126971182e+02 > > > > > 0 KSP Residual norm 2.222609581896e+00 > > > > > 1 KSP Residual norm 5.661437314341e-14 > > > > > Line search: gnorm after quadratic fit 6.235337602260e+02 > > > > > Line search: Quadratically determined step, lambda=2.1172883827013136e-01 > > > > > 14 SNES Function norm 6.235337602260e+02 > > > > > 0 KSP Residual norm 3.080209609798e+00 > > > > > 1 KSP Residual norm 6.073476899313e-14 > > > > > Line search: gnorm after quadratic fit 5.704745248520e+02 > > > > > Line search: Quadratically determined step, lambda=1.0142301129466913e-01 > > > > > 15 SNES Function norm 5.704745248520e+02 > > > > > 0 KSP Residual norm 5.628316803979e+00 > > > > > 1 KSP Residual norm 9.930477041779e-14 > > > > > Line search: gnorm after quadratic fit 5.401354794776e+02 > > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > > 16 SNES Function norm 5.401354794776e+02 > > > > > 0 KSP Residual norm 2.052541406719e+01 > > > > > 1 KSP Residual norm 4.328836834239e-13 > > > > > Line search: gnorm after quadratic fit 1.709850100987e+03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.717966555703e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.414032576976e+02 lambda=8.7805694170804971e-03 > > > > > Line search: Cubically determined step, current gnorm 5.391967144330e+02 lambda=3.6341472475199424e-03 > > > > > 17 SNES Function norm 5.391967144330e+02 > > > > > 0 KSP Residual norm 2.246993769488e+00 > > > > > 1 KSP Residual norm 5.078373642913e-14 > > > > > Line search: gnorm after quadratic fit 4.939618639951e+02 > > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > > 18 SNES Function norm 4.939618639951e+02 > > > > > 0 KSP Residual norm 2.155867648564e+00 > > > > > 1 KSP Residual norm 4.438622106380e-14 > > > > > Line search: gnorm after quadratic fit 4.334377322188e+02 > > > > > Line search: Quadratically determined step, lambda=1.5092486954829210e-01 > > > > > 19 SNES Function norm 4.334377322188e+02 > > > > > 0 KSP Residual norm 8.318284791610e+00 > > > > > 1 KSP Residual norm 6.910116607023e-13 > > > > > Line search: gnorm after quadratic fit 6.148799641401e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.502386288041e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm 4.297879862602e+02 lambda=1.9565738732695813e-02 > > > > > 20 SNES Function norm 4.297879862602e+02 > > > > > 0 KSP Residual norm 7.593855254976e+01 > > > > > 1 KSP Residual norm 1.300639045149e-12 > > > > > Line search: gnorm after quadratic fit 7.318016560287e+04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.832525429452e+03 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.543595712952e+03 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.752901058720e+02 lambda=1.2500000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.309726315570e+02 lambda=1.2500000000000002e-03 > > > > > Line search: Cubically determined step, current gnorm 4.297464967378e+02 lambda=2.0986409143217158e-04 > > > > > 21 SNES Function norm 4.297464967378e+02 > > > > > 0 KSP Residual norm 8.492609701850e+00 > > > > > 1 KSP Residual norm 2.830329105288e-13 > > > > > Line search: gnorm after quadratic fit 6.575200413213e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.532760802544e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm 4.268212296998e+02 lambda=1.8460064973695799e-02 > > > > > 22 SNES Function norm 4.268212296998e+02 > > > > > 0 KSP Residual norm 2.527155905469e+00 > > > > > 1 KSP Residual norm 2.235724978394e-13 > > > > > Line search: gnorm after quadratic fit 3.958132075117e+02 > > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > > 23 SNES Function norm 3.958132075117e+02 > > > > > 0 KSP Residual norm 3.425644398425e+00 > > > > > 1 KSP Residual norm 7.166017790799e-14 > > > > > Line search: gnorm after quadratic fit 3.803199338641e+02 > > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > > 24 SNES Function norm 3.803199338641e+02 > > > > > 0 KSP Residual norm 3.581435186688e+00 > > > > > 1 KSP Residual norm 1.730091027109e-13 > > > > > Line search: gnorm after quadratic fit 3.678433353709e+02 > > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > > 25 SNES Function norm 3.678433353709e+02 > > > > > 0 KSP Residual norm 2.817439291614e+00 > > > > > 1 KSP Residual norm 8.592333136485e-13 > > > > > Line search: gnorm after quadratic fit 3.472671313564e+02 > > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > > 26 SNES Function norm 3.472671313564e+02 > > > > > 0 KSP Residual norm 1.830066839089e+00 > > > > > 1 KSP Residual norm 3.248934231575e-14 > > > > > Line search: gnorm after quadratic fit 3.195079998571e+02 > > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > > 27 SNES Function norm 3.195079998571e+02 > > > > > 0 KSP Residual norm 3.775823654589e+00 > > > > > 1 KSP Residual norm 1.316233059492e-13 > > > > > Line search: gnorm after quadratic fit 3.252874639934e+02 > > > > > Line search: Cubically determined step, current gnorm 3.125168318399e+02 lambda=5.0000000000000003e-02 > > > > > 28 SNES Function norm 3.125168318399e+02 > > > > > 0 KSP Residual norm 3.892613775622e+00 > > > > > 1 KSP Residual norm 7.093200713216e-11 > > > > > Line search: gnorm after quadratic fit 3.137590389484e+02 > > > > > Line search: Cubically determined step, current gnorm 3.045559021319e+02 lambda=5.0000000000000003e-02 > > > > > 29 SNES Function norm 3.045559021319e+02 > > > > > 0 KSP Residual norm 2.364531179390e+00 > > > > > 1 KSP Residual norm 1.615423543115e-12 > > > > > Line search: gnorm after quadratic fit 2.864449141431e+02 > > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > > 30 SNES Function norm 2.864449141431e+02 > > > > > 0 KSP Residual norm 5.187063704081e+00 > > > > > 1 KSP Residual norm 4.254799504045e-13 > > > > > Line search: gnorm after quadratic fit 3.171238299438e+02 > > > > > Line search: Cubically determined step, current gnorm 2.859321807369e+02 lambda=4.9550691080557742e-02 > > > > > 31 SNES Function norm 2.859321807369e+02 > > > > > 0 KSP Residual norm 2.400449127985e+01 > > > > > 1 KSP Residual norm 5.221032480453e-13 > > > > > Line search: gnorm after quadratic fit 1.812538817802e+03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.647888939229e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.905120335847e+02 lambda=7.3371687404129469e-03 > > > > > Line search: Cubically determined step, current gnorm 2.857698450683e+02 lambda=1.3231746793531958e-03 > > > > > 32 SNES Function norm 2.857698450683e+02 > > > > > 0 KSP Residual norm 7.438521293559e+00 > > > > > 1 KSP Residual norm 1.293652874831e-12 > > > > > Line search: gnorm after quadratic fit 3.600694148787e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.932936811991e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm 2.832774969882e+02 lambda=1.8636088141277370e-02 > > > > > 33 SNES Function norm 2.832774969882e+02 > > > > > 0 KSP Residual norm 2.676138557891e+00 > > > > > 1 KSP Residual norm 5.204105674042e-12 > > > > > Line search: gnorm after quadratic fit 2.698470565576e+02 > > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > > 34 SNES Function norm 2.698470565576e+02 > > > > > 0 KSP Residual norm 1.009562156863e+01 > > > > > 1 KSP Residual norm 3.544140587695e-13 > > > > > Line search: gnorm after quadratic fit 5.672695948559e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.197216154647e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm 2.694068135292e+02 lambda=1.0762403784106927e-02 > > > > > 35 SNES Function norm 2.694068135292e+02 > > > > > 0 KSP Residual norm 3.927549314525e+00 > > > > > 1 KSP Residual norm 2.619134786598e-13 > > > > > Line search: gnorm after quadratic fit 2.646675787349e+02 > > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > > 36 SNES Function norm 2.646675787349e+02 > > > > > 0 KSP Residual norm 3.630219417922e+01 > > > > > 1 KSP Residual norm 1.546302717349e-12 > > > > > Line search: gnorm after quadratic fit 1.827432666108e+04 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.342968941151e+03 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.008633273369e+02 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.490753494196e+02 lambda=1.2345129233072847e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.682474011960e+02 lambda=3.3291959087019770e-03 > > > > > Line search: Cubically determined step, current gnorm 2.646227701989e+02 lambda=4.0529212866107715e-04 > > > > > 37 SNES Function norm 2.646227701989e+02 > > > > > 0 KSP Residual norm 8.122774697994e+00 > > > > > 1 KSP Residual norm 1.316362046092e-13 > > > > > Line search: gnorm after quadratic fit 4.731092571363e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.030088374328e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm 2.637462652877e+02 lambda=9.1057248517509397e-03 > > > > > 38 SNES Function norm 2.637462652877e+02 > > > > > 0 KSP Residual norm 2.601520363063e+00 > > > > > 1 KSP Residual norm 1.060764270007e-12 > > > > > Line search: gnorm after quadratic fit 2.536856446094e+02 > > > > > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > > > > > 39 SNES Function norm 2.536856446094e+02 > > > > > 0 KSP Residual norm 5.447955134327e+01 > > > > > 1 KSP Residual norm 2.556989975730e-12 > > > > > Line search: gnorm after quadratic fit 9.199250935618e+03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.998238940105e+03 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.227083769291e+02 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.852215674478e+02 lambda=8.5024965111563117e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.537821339347e+02 lambda=8.5024965111563122e-04 > > > > > Line search: Cubically determined step, current gnorm 2.536484146652e+02 lambda=2.9594242443314720e-04 > > > > > 40 SNES Function norm 2.536484146652e+02 > > > > > 0 KSP Residual norm 3.357359266965e+01 > > > > > 1 KSP Residual norm 8.485166742752e-11 > > > > > Line search: gnorm after quadratic fit 3.327150899857e+03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.660943990394e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.428891921377e+02 lambda=2.2262238648584176e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.550059920785e+02 lambda=3.9120439672600755e-03 > > > > > Line search: Cubically determined step, current gnorm 2.535425543202e+02 lambda=8.8078244093807846e-04 > > > > > 41 SNES Function norm 2.535425543202e+02 > > > > > 0 KSP Residual norm 1.982789391732e+01 > > > > > 1 KSP Residual norm 1.156473750758e-11 > > > > > Line search: gnorm after quadratic fit 9.648483369708e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.023504841042e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.554919970151e+02 lambda=8.7092873850291869e-03 > > > > > Line search: Cubically determined step, current gnorm 2.532490636747e+02 lambda=2.4564558988847251e-03 > > > > > 42 SNES Function norm 2.532490636747e+02 > > > > > 0 KSP Residual norm 1.762994613361e+01 > > > > > 1 KSP Residual norm 4.550684860593e-12 > > > > > Line search: gnorm after quadratic fit 6.772107527838e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.370541870778e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.532869639177e+02 lambda=7.7662700854918328e-03 > > > > > Line search: Cubically determined step, current gnorm 2.527651129995e+02 lambda=3.8686733161537824e-03 > > > > > 43 SNES Function norm 2.527651129995e+02 > > > > > 0 KSP Residual norm 1.559278923951e+01 > > > > > 1 KSP Residual norm 1.060470887103e-11 > > > > > Line search: gnorm after quadratic fit 7.344361373020e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.498001534426e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.530518382567e+02 lambda=7.6730113050967469e-03 > > > > > Line search: Cubically determined step, current gnorm 2.523423548732e+02 lambda=3.4156098513217236e-03 > > > > > 44 SNES Function norm 2.523423548732e+02 > > > > > 0 KSP Residual norm 1.190500639095e+01 > > > > > 1 KSP Residual norm 6.311739265577e-12 > > > > > Line search: gnorm after quadratic fit 4.875196633557e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.933215922947e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm 2.516782376717e+02 lambda=9.8878729665301743e-03 > > > > > 45 SNES Function norm 2.516782376717e+02 > > > > > 0 KSP Residual norm 1.003632001309e+01 > > > > > 1 KSP Residual norm 7.039473047666e-13 > > > > > Line search: gnorm after quadratic fit 3.417133560813e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.636443273929e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm 2.499729768042e+02 lambda=1.5332495922160540e-02 > > > > > 46 SNES Function norm 2.499729768042e+02 > > > > > 0 KSP Residual norm 5.252587112411e+01 > > > > > 1 KSP Residual norm 2.072629114336e-12 > > > > > Line search: gnorm after quadratic fit 7.891803681498e+03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.819076698717e+03 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 5.911876424956e+02 lambda=2.4538865368827514e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.688195882303e+02 lambda=6.5764457912135515e-03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.500076295129e+02 lambda=6.5764457912135523e-04 > > > > > Line search: Cubically determined step, current gnorm 2.499390700783e+02 lambda=2.7231956365922875e-04 > > > > > 47 SNES Function norm 2.499390700783e+02 > > > > > 0 KSP Residual norm 4.007648116930e+01 > > > > > 1 KSP Residual norm 5.646654234336e-11 > > > > > Line search: gnorm after quadratic fit 6.276152857499e+03 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.418274035925e+03 lambda=5.0000000000000003e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 4.785345842563e+02 lambda=2.5000000000000001e-02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 2.665412152699e+02 lambda=8.0607289886479045e-03 > > > > > Line search: Cubically determined step, current gnorm 2.499109739904e+02 lambda=8.0607289886479045e-04 > > > > > 48 SNES Function norm 2.499109739904e+02 > > > > > 0 KSP Residual norm 1.339756751889e+01 > > > > > 1 KSP Residual norm 2.559175980945e-13 > > > > > Line search: gnorm after quadratic fit 6.052259901869e+02 > > > > > Line search: Cubic step no good, shrinking lambda, current gnorm 3.217431518450e+02 lambda=5.0000000000000003e-02 > > > > > Line search: Cubically determined step, current gnorm 2.496541765916e+02 lambda=7.0239599632283649e-03 > > > > > 49 SNES Function norm 2.496541765916e+02 > > > > > 0 KSP Residual norm 5.340771873687e+00 > > > > > 1 KSP Residual norm 1.207454778077e-13 > > > > > Line search: gnorm after quadratic fit 2.760767095070e+02 > > > > > Line search: Cubically determined step, current gnorm 2.491630276458e+02 lambda=5.0000000000000003e-02 > > > > > 50 SNES Function norm 2.491630276458e+02 > > > > > > > > > > > > > > > On Sat, Aug 26, 2017 at 11:45 PM, Barry Smith wrote: > > > > > > > > > > > On Aug 26, 2017, at 10:43 PM, zakaryah . wrote: > > > > > > > > > > > > Hi Barry - many thanks for taking the time to understand my many problems and providing so much help. > > > > > > > > > > > > The reason I was concerned that I could not alter the linesearch was when I tried to use bt instead of the L-BFGS default, cp, the code crashed with an error like "Could not get Jacobian". Maybe this is an incompatibility like you say, since L-BFGS only uses the initial Jacobian and I never tried setting the scale type. > > > > > > > > > > > > I took your advice and tried to shrink the problem. First I tried shrinking by a factor 1000 but this converged very quickly with all test data I could provide, including the data which was problematic with the large grid. So I settled for a reduction in size by a factor 125. The grid size is 13,230. This is a decent test case because the solver fails to converge with the options I was using before, and it is small enough that I can run it with the options you suggested (-snes_fd_color -snes_type newtonls -snes_monitor -snes_linesearch_monitor -ksp_monitor -pc_type lu). > > > > > > > > > > > > The output is 1800 lines long - how shall I share it? > > > > > > > > > > Just email it, that is small enough for email. > > > > > > > > > > Barry > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > On Sat, Aug 26, 2017 at 7:38 PM, Barry Smith wrote: > > > > > > > > > > > > > On Aug 26, 2017, at 5:56 PM, zakaryah . wrote: > > > > > > > > > > > > > > I'm using PETSc's SNES methods to solve PDEs which result from Euler-Lagrange equations for the strain energy of a 3D displacement field. There is an additional term in the Lagrangian which describes external forces which arise from various data sets, and that term contains nonlinearities (field terms higher than linear). The grid has about 1.6e6 elements, and the displacement field has 3 components at each grid element. > > > > > > > > > > > > > > I'm trying to solve a sequence of successively more complicated equations, and the latest equation is failing to converge on some data sets. In particular, the methods were successful for the infinitesimal bulk strain (compression) energy, as well as the full infinitesimal strain energy (bulk + shear), but I'm now trying to generalize to the finite strain, as certain data sets are known to result from displacement fields for which the infinitesimal strain is a poor approximation. > > > > > > > > > > > > > > I'm using a DMDA, closely following example 48, and my preferred solver is L-BFGS. > > > > > > > > > > > > So you are using ? > > > > > > > > > > > > -snes_type qn -snes_qn_type lbfgs > > > > > > > > > > > > > > > > > > > > I have read the FAQs "Why is Newton's method not converging??" and "Why is my iterative linear solver not converging??"? which have raised a number of questions: > > > > > > > > > > > > Quasi Newton methods either don't use Jacobians or use only the initial Jacobian (the idea behind quasi-Newton methods is to approximate Jacobian information from previous iterations without having the user compute a Jacobian at each iteration). With PETSc's qn it only uses the Jacobian if you use the option > > > > > > > > > > > > -snes_qn_scale_type Jacobian > > > > > > > > > > > > otherwise the Jacobian is never computed or used > > > > > > > > > > > > > > > > > > > > > > > > > > Is there documentation for the DMDA/SNES methods somewhere? I don't understand these very well. For example, I am not allocating any matrix for the global Jacobian, and I believe this prevents me from changing the line search. If I'm mistaken I would love to see an example of changing the line search type while using DMDA/SNES. > > > > > > > > > > > > Whether you provide a Jacobian or not is orthogonal to the line search. > > > > > > > > > > > > You should be able to change the line search with > > > > > > > > > > > > -snes_linesearch_type bt or nleqerr or basic or l2 or cp > > > > > > > > > > > > not all of them may work with qn > > > > > > > > > > > > > > > > > > > > > > > > > > I don't know how to interpret the linesearch monitor. Even for problems which are converging properly, the linesearch monitor reports "lssucceed=0" on every iteration. Is this a problem? > > > > > > > > > > > > It returns a 0 if the line search does not believe it has achieved "sufficient decrease" in the function norm (or possibly some other measure of decrease) you should run -snes_linesearch_monitor also with the option -snes_monitor to see what is happening to the function norm > > > > > > > > > > > > For qn you can add the option > > > > > > > > > > > > -snes_qn_monitor > > > > > > > > > > > > to get more detailed monitoring > > > > > > > > > > > > > > > > > > > > > > > > > > I'm also having trouble understanding the methods for troubleshooting. I suspect that I've made an error in the analytical Jacobian, which has a rather large number of non-zero elements, but I have no idea how to use -snes_type test -snes_test_display. The FAQs mention that some troubleshooting tools are more useful for small test problems. How small is small? > > > > > > > > > > > > Tiny, at most a few dozen rows and columns in the Jacobin. > > > > > > > > > > > > You should run without the -snes_test_display information, what does it say? Does it indicate the Jacobian or report there is likely a problem? > > > > > > > > > > > > With DMDA you can also use -snes_fd_color to have PETSc compute the Jacobian for you instead of using your analytical form. If it works with this, but not your Jacobian then your Jacobian is wrong. > > > > > > > > > > > > > When I try to run the program with -snes_type test -snes_test_display, I get errors like: > > > > > > > > > > > > > > [0]PETSC ERROR: Argument out of range [0]PETSC ERROR: Local index 1076396032 too large 4979879 (max) at 0 > > > > > > > > > > > > > > The second size is 1 less than the number of field elements, while the first number seems too large for any aspect of the problem - the Jacobian has at most 59 non-zero columns per row. > > > > > > > > > > > > > > Because I suspect a possible error in the Jacobian, I ran with -snes_mf_operator -pc_type ksp -ksp_ksp_rtol 1e-12 and observed very similar failure to converge (diverging residual) as with the explicit Jacobian. > > > > > > > > > > > > What do you get with -ksp_monitor -ksp_ksp_monitor it sounds like the true Jacobian is either very ill-conditioned or your function evaluation is wrong. > > > > > > > > > > > > > Do I need to set an SNES method which is somehow compatible with the "matrix-free" approach? If I instead use -snes_mf, the problem seems to converge, but horrendously slowly (true residual relative decrease by about 1e-5 per iteration). I suppose this supports my suspicion that the Jacobian is incorrect but doesn't really suggest a solution. > > > > > > > > > > > > > > Is it possible that the analytical Jacobian is correct, but somehow pathological, which causes the SNES to diverge? > > > > > > > > > > > > Yes > > > > > > > > > > > > > Neither the Jacobian nor the function have singularities. > > > > > > > > > > > > > > Thanks for any help you can provide! > > > > > > > > > > > > Try really hard to set up a small problem (like just use a very coarse grid) to experiment with as you try to get convergence. Using a big problem for debugging convergence is a recipe for pain. > > > > > > > > > > > > Also since you have a Jacobian I would start with -snes_fd_color -snes_type ls -snes_monitor -snes_linesearch_monitor -ksp_monitor -pc_type lu (not on a huge problem), what happens? Send the output > > > > > > > > > > > > Barry > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > From zakaryah at gmail.com Mon Aug 28 00:13:04 2017 From: zakaryah at gmail.com (zakaryah .) Date: Mon, 28 Aug 2017 01:13:04 -0400 Subject: [petsc-users] A number of questions about DMDA with SNES and Quasi-Newton methods In-Reply-To: References: <020DAED9-AAAD-4741-976B-BB2EF6C79D3F@mcs.anl.gov> <5BF530F6-8D79-47E6-B2C5-B0702FF2AA59@mcs.anl.gov> <7EE84495-4346-4BFB-B9AD-BCAA3C722461@mcs.anl.gov> <08AA1273-062D-4FDD-8709-40AA1FE8AA92@mcs.anl.gov> <06932E72-E8F3-4EA8-889F-A570AD660E32@mcs.anl.gov> Message-ID: Any clues on what I should test with the debugger? Just running with "-snes_type test -snes_test_display -start_in_debugger noxterm" the debugger reports a PETSc error: MatSetValues_SeqAIJ(), Inserting a new nonzero at (7,0) in the matrix (7,0) is certainly within the allocated space, considering the call to DMDACreate3d() that I sent before. I'm suspicious that the -snes_type test is somehow incompatible with the DMDA, at least without somehow initializing the Jacobian. -------------- next part -------------- An HTML attachment was scrubbed... URL: From C.Klaij at marin.nl Mon Aug 28 02:55:47 2017 From: C.Klaij at marin.nl (Klaij, Christiaan) Date: Mon, 28 Aug 2017 07:55:47 +0000 Subject: [petsc-users] Petsc ILU PC Change between 3.6.4 and 3.7.x? In-Reply-To: <87lgm9kl8s.fsf@jedbrown.org> References: <1503409741903.19202@marin.nl> <6EABE1D7-CCD2-4D1F-8DD4-D1092F0D85DE@mcs.anl.gov> <1503469637346.49904@marin.nl> <1503556176418.81994@marin.nl>,<87lgm9kl8s.fsf@jedbrown.org> Message-ID: <1503906947824.24460@marin.nl> Hi Jed, Thanks for clarifying, I understand the two-sided bound and the condition number. So for left preconditioning we would have P_L A instead of A in this bound and P_L r instead of r. For right preconditioning it is less obvious to me. How much would that loosen the bound? Chris dr. ir. Christiaan Klaij | Senior Researcher | Research & Development MARIN | T +31 317 49 33 44 | mailto:C.Klaij at marin.nl | http://www.marin.nl MARIN news: http://www.marin.nl/web/News/News-items/Improved-modelling-of-sheet-cavitation-dynamics-on-Delft-Twistll-Hydrofoil-1.htm ________________________________________ From: Jed Brown Sent: Thursday, August 24, 2017 6:01 PM To: Klaij, Christiaan; Matthew Knepley; Barry Smith Cc: petsc-users at mcs.anl.gov Subject: Re: [petsc-users] Petsc ILU PC Change between 3.6.4 and 3.7.x? "Klaij, Christiaan" writes: > Matt, > > Thanks, I can understand the lower condition number of P A, but > what about r? Doesn't that change to P r and if so why can we > assume that ||r|| and ||P r|| have the same order? Matt's equation was of course wrong in a literal sense, but is based on the right moral convictions. We have r = A (x - x_exact) which implies that ||r|| <= ||A|| || x - x_exact ||. We also have x - x_exact = A^{-1} r so || x - x_exact || <= || A^{-1} || ||r||. Combining these gives the two-sided bound || A ||^{-1} ||r|| <= || x - x_exact || <= || A^{-1} || ||r||. The ratio of the high and low bounds is the condition number. Our convergence tolerance controls the norm of the residual (in a relative or absolute sense). If the condition number is smaller, we get tighter control on the error. If you are confident that your preconditioner reduces the condition number, it makes sense to measure convergence in the preconditioned norm (this is natural with left preconditioning for GMRES), in which the bounds above are in terms of the preconditioned operator. The main reason for PETSc to keep the preconditioned norm as a default is that many users, especially beginners, produce poorly scaled equations, e.g., with penalty boundary conditions or with disparate scales between fields with different units (displacement, pressure, velocity, energy, etc.). You will often see the unpreconditioned residual drop by 10 orders of magnitude on the first iteration because the penalty boundary conditions are satisfied despite the solution being completely wrong inside the domain. On the other hand, the preconditioned residual causes misdiagnosis of convergence if the preconditioner is (nearly) singular, as is the case with some preconditioners applied to saddle point problems, for example. But this is easy to identify using -ksp_monitor_true_residual. > > Chris > > > dr. ir. Christiaan Klaij | Senior Researcher | Research & Development > MARIN | T +31 317 49 33 44 | C.Klaij at marin.nl | www.marin.nl > > [LinkedIn] [YouTube] [Twitter] [Facebook] > MARIN news: New C-DRONE - for undisturbed wave spectrum measurements > > ________________________________ > From: Matthew Knepley > Sent: Wednesday, August 23, 2017 8:37 AM > To: Barry Smith > Cc: Klaij, Christiaan; petsc-users at mcs.anl.gov > Subject: Re: [petsc-users] Petsc ILU PC Change between 3.6.4 and 3.7.x? > > On Wed, Aug 23, 2017 at 2:30 AM, Barry Smith > wrote: > > Some argue that the preconditioned residual is "closer to" the norm of the error than the unpreconditioned norm. I don't have a solid mathematical reason to prefer left preconditioning with the preconditioned norm. > > Because you have || x - x_exact || < k(A) || r || > > where r is the residual and k is the condition number of A. If instead of A you use P A, which we assume has a lower condition number, then > this bound is improved. > > Thanks, > > Matt > > > Barry > > > >> On Aug 22, 2017, at 11:27 PM, Klaij, Christiaan > wrote: >> >> Barry, >> >> Thanks for the explanation. >> >> We do have some rare cases that give false convergence, but >> decided to use >> >> CALL KSPSetNormType(ksp,KSP_NORM_UNPRECONDITIONED,ierr) >> >> so that convergence is always based on the true residual. Our >> results are much more consistent now. So that could have been >> your protection against the rare case as well, right? Why do you >> prefer left preconditioning? >> >> Chris >> >> >> >> dr. ir. Christiaan Klaij | Senior Researcher | Research & Development >> MARIN | T +31 317 49 33 44 | mailto:C.Klaij at marin.nl | http://www.marin.nl >> >> MARIN news: http://www.marin.nl/web/News/News-items/BlueWeek-October-911-Rostock.htm >> >> ________________________________________ >> From: Barry Smith > >> Sent: Tuesday, August 22, 2017 6:25 PM >> To: Klaij, Christiaan >> Cc: petsc-users at mcs.anl.gov >> Subject: Re: [petsc-users] Petsc ILU PC Change between 3.6.4 and 3.7.x? >> >>> On Aug 22, 2017, at 6:49 AM, Klaij, Christiaan > wrote: >>> >>> We also faced this problem in our code. So I've added: >>> >>> CALL PetscOptionsSetValue(PETSC_NULL_OBJECT,"-sub_pc_factor_shift_type","nonzero",ierr) >>> >>> since there seems to be no setter function for this (correct me >>> if I'm wrong). Then everythings fine again. >>> >>> Out of curiosity, what was the reason to change the default >>> behaviour? >> >> The reason we changed this is that we would rather have a failure that makes the user aware of a serious problem then to produce "garbage" results. In some rare cases the shift can cause a huge jump in the preconditioned residual which then decreases rapidly while the true residual does not improve. This results in the KSP thinking it has converged while in fact it has essentially garbage for an answer. Under the previous model, where we shifted by default, users would in this rare case think they had reasonable solutions when they did not. >> >> For many users, such as yourself, the previous default behavior was fine because you didn't have the "rare case" but we decided it was best to protect against the rare case even though it would require other users such as yourself to add the option. >> >> Barry > > > > > -- > What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. > -- Norbert Wiener > > http://www.caam.rice.edu/~mk51/ From weyenst at gmail.com Mon Aug 28 03:15:03 2017 From: weyenst at gmail.com (Toon Weyens) Date: Mon, 28 Aug 2017 08:15:03 +0000 Subject: [petsc-users] Parallel dense solve with submatrices In-Reply-To: References: Message-ID: Thank you Barry, that explains why I couldn't find information about it. I am now going to implement this straight-forward implementation as a first step. In the long term it would in any case be useful to have a solver that uses H-matrices, such as H2lib. Is there any chance Petsc is thinking about moving to this kind of matrices as well in the future? On Sun, Aug 27, 2017 at 12:54 AM Barry Smith wrote: > > Toon, > > We don't have any such way of doing this. Note that sparse > factorization packages store the "factors" in specialized data structures > that are unlikely to be acessable to perform such operations as you > describe below. > > I think what you want to do is an over optimization not worth the > coding effort. > > Barry > > > On Aug 25, 2017, at 5:01 AM, Toon Weyens wrote: > > > > Dear all, > > > > For a Bounday Element Method problem I require the solution of a system > of linear equations with multiple right-hand sides. Though this is a dense > system, I still want to do it via Petsc. Would the best way to do this be > through something such as > > > > -ksp_type preonly -pc_type lu -pc_factor_mat_solver_package mumps ? > > > > Furthermore, I refine my grid in a regular way, which leads to a new > system of equations of size 2N x 2N where N is the original number of > unknowns before refining it. The upper-left matrix A_11 in this new system > is identical to the unrefined matrix (multiplied by 0.5). The other three > blocks A_12, A_21 and A_22 are new: > > > > A_11 A_12 > > A_21 A_22 > > > > The question is now whether knowledge about the unrefined matrix A_11 > can be used to speed up calculation of the refined system? > > > > I was thinking, for example, about using the LU decomposition of A_11 to > calculate the LU decomposition of the entire matrix A using the well-known > formula's > > > > L_21 U_11 = A_21 > > L_11 U_12 = A_12 > > L_22 U_22 = A_22 - L_21 U_12 > > > > where L_21 and U_12 are full matrices, L_11, L_22 are lower triangular > matrices and U_11, U_22 are upper triangular. > > > > Is there any way to do this in Petsc? > > > > Or is there a better thing I can do? > > > > Thanks very much in advance! > > > > Regards. > > > > Dr. Toon Weyens > > ITER Organization > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From imilian.hartig at gmail.com Mon Aug 28 04:15:05 2017 From: imilian.hartig at gmail.com (Maximilian Hartig) Date: Mon, 28 Aug 2017 11:15:05 +0200 Subject: [petsc-users] accessing fields from previous, converged solution. In-Reply-To: <9056F8CB-FAAC-4B63-B498-FDD84C9EC2DF@gmail.com> References: <5E7F9366-B000-4F24-9E0B-9CE8BF0FA2E5@gmail.com> <9056F8CB-FAAC-4B63-B498-FDD84C9EC2DF@gmail.com> Message-ID: Sorry to bother you again, but I have checked and rechecked my formulation and it corresponds to what I have found in literature. The only difference is that my flow criteria is not evaluated using the trial stress and the current yield stress but rather the corrected stress and the updated yield stress. I am convinced this is what causes the problem. Unfortunately I do not have any idea on how to go about implementing this. First I don?t know how to access the solution from the past iteration and secondly I don?t know how to do the elastic predictor step. I tried doing it with auxiliary fields that get updated every timestep but I gather that is not a good idea. Could you please point me in some direction? I appreciate you patience with my questioning. Thanks, Max > On 22. Aug 2017, at 13:52, Maximilian Hartig wrote: > >> >> On 17. Aug 2017, at 13:51, Matthew Knepley > wrote: >> >> On Thu, Aug 17, 2017 at 3:13 AM, Maximilian Hartig > wrote: >> Thanks for your help Matt. >>> On 16. Aug 2017, at 16:17, Matthew Knepley > wrote: >>> >>> On Wed, Aug 16, 2017 at 8:56 AM, Maximilian Hartig > wrote: >>> Hello, >>> >>> I have a problem with several fields that I solve with PetscFE and TS. I now need to access the solution from the previous timestep to compute the residual for the current timestep. >>> I tried a TSMonitor with the following code in it: >>> >>> TSGetDM(ts,&dm); >>> DMClone(dm,&dm_aux); >>> DMGetDS(dm,&prob_aux); >>> DMSetDS(dm_aux,prob_aux); >>> DMCreateGlobalVector(dm_aux,&old_solution); >>> VecCopy(u,oldsolution); >>> PetscObjectCompose((PetscObject) dm, ?A?, (PetscObject) old_solution); >>> >>> VecDestroy(&old_solution); >>> DMDestroy(&dm_aux); >>> >>> hoping that it would create an auxiliary field that I could access in the evaluation of the residual. It did that but messed with the discretisation of the initial problem in some way. So I figure that adding auxiliary fields to a dm after having fed it to a TS context is not something you should be doing. >>> >>> Is there a way to access the fields of the solution for the previous timestep during the evaluation of the current residual? >>> >>> First, I can show you how to do what you are asking for. I think you can simply >>> >>> PetscObjectQuery((PetscObject) dm, "old_solution", (PetscObject *) &old_solution); >>> if (!old_solution) { >>> DMCreateGlobalVector(dm, &old_solution); >>> PetscObjectCompose((PetscObject) dm, "old_solution", old_solution); >>> } >>> VecCopy(u, oldsolution); >> >> Unfortunately, this produces an error and tells me ?An object cannot be composed with an object that was composed with it." >> >>> >>> Second, I think a better way to do this than composition is to use >>> >>> DMGetNamedGlobalVector(dm, "old_solution", &old_solution); >> >> Yes, this seems to work and I do not get an error while running the monitor. Also the discretisation seems to be fine. But the old solution now is not available as an auxiliary field. >> >>> >>> Third, I can say that I am profoundly troubled by this. This interferes with the operation of >>> the time integrator, and I cannot see a reason for this. If you are keeping track of the integral >>> of some quantity, I would update that in TSPostStep() and request that integral instead of the >>> previous solution. We do this for some non-Newtonian rheologies. >> >> I have an ?if? condition in my residual which I need to evaluate to determine the correct formulation for my residuals. I use actual fields to keep track of the integrals. But when I use the actual field to evaluate the ?if? condition, due to the implicit nature of the solver I jump ?back and forth? over that condition. I need the ?if? condition to be independent from the field for which it determines the residual. >> The actual application is as follows: >> I have, amongst others, a displacement and a stress field. >> I evaluate for my stress given a displacement increment delta u. >> If the resulting stress is > yield stress, I need a plasticity formulation, if it is smaller, I can use elasticity. >> >> Hmm, I think this is a formulation problem. You should be using the "correct" formulation at the implicit step, since otherwise >> the residual will be inconsistent with what you tested when evaluated at the new step. I have the same kind of elasto-plastic >> system in PyLith (http://www.geodynamics.org/cig/software/pylith/ ) which we solve implicitly without much problem. > > Possible, but I rechecked the formulation and it looks fine to me. In literature, this kind of algorithm uses an elastic predictor step to determine whether to use the elastic or the plastic formulation. The elastic ?trial? stress is compared with the yield stress from the past timestep. In my current setup, I do not compare the elastic ?trial? stress with the past yield stress but the current stress (including plastic correction) with the current yield stress. I think this is what leads to my problem. When I cheat and just tell petsc to use the plastic formulation from the time on where I expect plastic behaviour, I get convergence and the results look reasonable. > So I tried to implement a flow condition which would not change during the nonlinear solver iteration steps. If the first, elastic predictor step results in yielding then, in my understanding, from there on we should expect plastic behaviour and not jump ?back and forth? between plastic and elastic behaviour. > I have taken a look at pylith and it seems to use an explicit formulation for dynamic plasticity. I try to use an implicit formulation solving for displacement, stress, plastic strain and the plastic consistency operator at once. I am not aware of a possibility within the petsc framework to have an internal solver to compute stress state and internal variables depending on the displacement rate and then return to the outer iteration to solve for the correct displacements. This is how I found it done in literature. Is there a possibility to have such an ?internal? snes? > > Thanks, > Max >> >> Thanks, >> >> Matt >> >> Thanks, >> Max >> >>> >>> Thanks, >>> >>> Matt >>> >>> Thanks, >>> Max >>> >>> >>> >>> -- >>> What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. >>> -- Norbert Wiener >>> >>> http://www.caam.rice.edu/~mk51/ >> >> >> >> -- >> What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. >> -- Norbert Wiener >> >> http://www.caam.rice.edu/~mk51/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From jroman at dsic.upv.es Mon Aug 28 05:15:24 2017 From: jroman at dsic.upv.es (Jose E. Roman) Date: Mon, 28 Aug 2017 12:15:24 +0200 Subject: [petsc-users] Parallel dense solve with submatrices In-Reply-To: References: Message-ID: <1683B434-6F43-4682-AEB0-FFFEF48A3470@dsic.upv.es> > El 28 ago 2017, a las 10:15, Toon Weyens escribi?: > > Thank you Barry, that explains why I couldn't find information about it. I am now going to implement this straight-forward implementation as a first step. > > In the long term it would in any case be useful to have a solver that uses H-matrices, such as H2lib. > > Is there any chance Petsc is thinking about moving to this kind of matrices as well in the future? > > You can use H2lib in a PETSc program by wrapping it in a shell matrix. We did this some time ago https://doi.org/10.1016/j.cam.2012.07.021 Also, PETSc has an interface to STRUMPACK, but only to the sparse part and I guess what you need is the dense part. Jose From knepley at gmail.com Mon Aug 28 05:31:38 2017 From: knepley at gmail.com (Matthew Knepley) Date: Mon, 28 Aug 2017 06:31:38 -0400 Subject: [petsc-users] accessing fields from previous, converged solution. In-Reply-To: References: <5E7F9366-B000-4F24-9E0B-9CE8BF0FA2E5@gmail.com> <9056F8CB-FAAC-4B63-B498-FDD84C9EC2DF@gmail.com> Message-ID: On Mon, Aug 28, 2017 at 5:15 AM, Maximilian Hartig wrote: > Sorry to bother you again, but I have checked and rechecked my formulation > and it corresponds to what I have found in literature. The only difference > is that my flow criteria is not evaluated using the trial stress and the > current yield stress but rather the corrected stress and the updated yield > stress. I am convinced this is what causes the problem. > Unfortunately I do not have any idea on how to go about implementing this. > First I don?t know how to access the solution from the past iteration > I think you can do what you want using http://www.mcs.anl.gov/petsc/petsc-master/docs/manualpages/TS/TSSetPostStep.html In your function, you would TSGetSolution() and then copy it into an auxiliary vector you set. This avoids the problem of composition you had before. > and secondly I don?t know how to do the elastic predictor step. > You can always create another SNES and do a subsolve, maybe in http://www.mcs.anl.gov/petsc/petsc-master/docs/manualpages/TS/TSSetPreStep.html#TSSetPreStep which you then copy into an auxiliary vector, just as above. Tell me if I am missing something. Thanks, Matt > I tried doing it with auxiliary fields that get updated every timestep but > I gather that is not a good idea. Could you please point me in some > direction? > > I appreciate you patience with my questioning. > > Thanks, > Max > > On 22. Aug 2017, at 13:52, Maximilian Hartig > wrote: > > > On 17. Aug 2017, at 13:51, Matthew Knepley wrote: > > On Thu, Aug 17, 2017 at 3:13 AM, Maximilian Hartig com> wrote: > >> Thanks for your help Matt. >> >> On 16. Aug 2017, at 16:17, Matthew Knepley wrote: >> >> On Wed, Aug 16, 2017 at 8:56 AM, Maximilian Hartig < >> imilian.hartig at gmail.com> wrote: >> >>> Hello, >>> >>> I have a problem with several fields that I solve with PetscFE and TS. I >>> now need to access the solution from the previous timestep to compute the >>> residual for the current timestep. >>> I tried a TSMonitor with the following code in it: >>> >>> TSGetDM(ts,&dm); >>> DMClone(dm,&dm_aux); >>> DMGetDS(dm,&prob_aux); >>> DMSetDS(dm_aux,prob_aux); >>> DMCreateGlobalVector(dm_aux,&old_solution); >>> VecCopy(u,oldsolution); >>> PetscObjectCompose((PetscObject) dm, ?A?, (PetscObject) old_solution); >>> >>> VecDestroy(&old_solution); >>> DMDestroy(&dm_aux); >>> >>> hoping that it would create an auxiliary field that I could access in >>> the evaluation of the residual. It did that but messed with the >>> discretisation of the initial problem in some way. So I figure that adding >>> auxiliary fields to a dm after having fed it to a TS context is not >>> something you should be doing. >>> >>> Is there a way to access the fields of the solution for the previous >>> timestep during the evaluation of the current residual? >>> >> >> First, I can show you how to do what you are asking for. I think you can >> simply >> >> PetscObjectQuery((PetscObject) dm, "old_solution", (PetscObject *) >> &old_solution); >> if (!old_solution) { >> DMCreateGlobalVector(dm, &old_solution); >> PetscObjectCompose((PetscObject) dm, "old_solution", old_solution); >> } >> VecCopy(u, oldsolution); >> >> >> Unfortunately, this produces an error and tells me ?An object cannot be >> composed with an object that was composed with it." >> >> >> Second, I think a better way to do this than composition is to use >> >> DMGetNamedGlobalVector(dm, "old_solution", &old_solution); >> >> >> Yes, this seems to work and I do not get an error while running the >> monitor. Also the discretisation seems to be fine. But the old solution now >> is not available as an auxiliary field. >> >> >> Third, I can say that I am profoundly troubled by this. This interferes >> with the operation of >> the time integrator, and I cannot see a reason for this. If you are >> keeping track of the integral >> of some quantity, I would update that in TSPostStep() and request that >> integral instead of the >> previous solution. We do this for some non-Newtonian rheologies. >> >> >> I have an ?if? condition in my residual which I need to evaluate to >> determine the correct formulation for my residuals. I use actual fields to >> keep track of the integrals. But when I use the actual field to evaluate >> the ?if? condition, due to the implicit nature of the solver I jump ?back >> and forth? over that condition. I need the ?if? condition to be independent >> from the field for which it determines the residual. >> The actual application is as follows: >> I have, amongst others, a displacement and a stress field. >> I evaluate for my stress given a displacement increment delta u. >> If the resulting stress is > yield stress, I need a plasticity >> formulation, if it is smaller, I can use elasticity. >> > > Hmm, I think this is a formulation problem. You should be using the > "correct" formulation at the implicit step, since otherwise > the residual will be inconsistent with what you tested when evaluated at > the new step. I have the same kind of elasto-plastic > system in PyLith (http://www.geodynamics.org/cig/software/pylith/) which > we solve implicitly without much problem. > > > Possible, but I rechecked the formulation and it looks fine to me. In > literature, this kind of algorithm uses an elastic predictor step to > determine whether to use the elastic or the plastic formulation. The > elastic ?trial? stress is compared with the yield stress from the past > timestep. In my current setup, I do not compare the elastic ?trial? stress > with the past yield stress but the current stress (including plastic > correction) with the current yield stress. I think this is what leads to my > problem. When I cheat and just tell petsc to use the plastic formulation > from the time on where I expect plastic behaviour, I get convergence and > the results look reasonable. > So I tried to implement a flow condition which would not change during the > nonlinear solver iteration steps. If the first, elastic predictor step > results in yielding then, in my understanding, from there on we should > expect plastic behaviour and not jump ?back and forth? between plastic and > elastic behaviour. > I have taken a look at pylith and it seems to use an explicit formulation > for dynamic plasticity. I try to use an implicit formulation solving for > displacement, stress, plastic strain and the plastic consistency operator > at once. I am not aware of a possibility within the petsc framework to have > an internal solver to compute stress state and internal variables depending > on the displacement rate and then return to the outer iteration to solve > for the correct displacements. This is how I found it done in literature. > Is there a possibility to have such an ?internal? snes? > > Thanks, > Max > > > Thanks, > > Matt > > >> Thanks, >> Max >> >> >> Thanks, >> >> Matt >> >> >>> Thanks, >>> Max >> >> >> >> >> -- >> What most experimenters take for granted before they begin their >> experiments is infinitely more interesting than any results to which their >> experiments lead. >> -- Norbert Wiener >> >> http://www.caam.rice.edu/~mk51/ >> >> >> > > > -- > What most experimenters take for granted before they begin their > experiments is infinitely more interesting than any results to which their > experiments lead. > -- Norbert Wiener > > http://www.caam.rice.edu/~mk51/ > > > -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener http://www.caam.rice.edu/~mk51/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From jed at jedbrown.org Mon Aug 28 06:09:39 2017 From: jed at jedbrown.org (Jed Brown) Date: Mon, 28 Aug 2017 05:09:39 -0600 Subject: [petsc-users] Petsc ILU PC Change between 3.6.4 and 3.7.x? In-Reply-To: <1503906947824.24460@marin.nl> References: <1503409741903.19202@marin.nl> <6EABE1D7-CCD2-4D1F-8DD4-D1092F0D85DE@mcs.anl.gov> <1503469637346.49904@marin.nl> <1503556176418.81994@marin.nl> <87lgm9kl8s.fsf@jedbrown.org> <1503906947824.24460@marin.nl> Message-ID: <87y3q4gd8s.fsf@jedbrown.org> "Klaij, Christiaan" writes: > Hi Jed, > > Thanks for clarifying, I understand the two-sided bound and the > condition number. So for left preconditioning we would have P_L A > instead of A in this bound and P_L r instead of r. For right > preconditioning it is less obvious to me. How much would that > loosen the bound? Right preconditioning works with the *unpreconditioned* residual norm. > Chris > > > dr. ir. Christiaan Klaij | Senior Researcher | Research & Development > MARIN | T +31 317 49 33 44 | mailto:C.Klaij at marin.nl | http://www.marin.nl > > MARIN news: http://www.marin.nl/web/News/News-items/Improved-modelling-of-sheet-cavitation-dynamics-on-Delft-Twistll-Hydrofoil-1.htm > > ________________________________________ > From: Jed Brown > Sent: Thursday, August 24, 2017 6:01 PM > To: Klaij, Christiaan; Matthew Knepley; Barry Smith > Cc: petsc-users at mcs.anl.gov > Subject: Re: [petsc-users] Petsc ILU PC Change between 3.6.4 and 3.7.x? > > "Klaij, Christiaan" writes: > >> Matt, >> >> Thanks, I can understand the lower condition number of P A, but >> what about r? Doesn't that change to P r and if so why can we >> assume that ||r|| and ||P r|| have the same order? > > Matt's equation was of course wrong in a literal sense, but is based on > the right moral convictions. We have > > r = A (x - x_exact) > > which implies that > > ||r|| <= ||A|| || x - x_exact ||. > > We also have > > x - x_exact = A^{-1} r > > so > > || x - x_exact || <= || A^{-1} || ||r||. > > Combining these gives the two-sided bound > > || A ||^{-1} ||r|| <= || x - x_exact || <= || A^{-1} || ||r||. > > The ratio of the high and low bounds is the condition number. Our > convergence tolerance controls the norm of the residual (in a relative > or absolute sense). If the condition number is smaller, we get tighter > control on the error. If you are confident that your preconditioner > reduces the condition number, it makes sense to measure convergence in > the preconditioned norm (this is natural with left preconditioning for > GMRES), in which the bounds above are in terms of the preconditioned > operator. > > The main reason for PETSc to keep the preconditioned norm as a default > is that many users, especially beginners, produce poorly scaled > equations, e.g., with penalty boundary conditions or with disparate > scales between fields with different units (displacement, pressure, > velocity, energy, etc.). You will often see the unpreconditioned > residual drop by 10 orders of magnitude on the first iteration because > the penalty boundary conditions are satisfied despite the solution being > completely wrong inside the domain. > > On the other hand, the preconditioned residual causes misdiagnosis of > convergence if the preconditioner is (nearly) singular, as is the case > with some preconditioners applied to saddle point problems, for example. > But this is easy to identify using -ksp_monitor_true_residual. > > >> >> Chris >> >> >> dr. ir. Christiaan Klaij | Senior Researcher | Research & Development >> MARIN | T +31 317 49 33 44 | C.Klaij at marin.nl | www.marin.nl >> >> [LinkedIn] [YouTube] [Twitter] [Facebook] >> MARIN news: New C-DRONE - for undisturbed wave spectrum measurements >> >> ________________________________ >> From: Matthew Knepley >> Sent: Wednesday, August 23, 2017 8:37 AM >> To: Barry Smith >> Cc: Klaij, Christiaan; petsc-users at mcs.anl.gov >> Subject: Re: [petsc-users] Petsc ILU PC Change between 3.6.4 and 3.7.x? >> >> On Wed, Aug 23, 2017 at 2:30 AM, Barry Smith > wrote: >> >> Some argue that the preconditioned residual is "closer to" the norm of the error than the unpreconditioned norm. I don't have a solid mathematical reason to prefer left preconditioning with the preconditioned norm. >> >> Because you have || x - x_exact || < k(A) || r || >> >> where r is the residual and k is the condition number of A. If instead of A you use P A, which we assume has a lower condition number, then >> this bound is improved. >> >> Thanks, >> >> Matt >> >> >> Barry >> >> >> >>> On Aug 22, 2017, at 11:27 PM, Klaij, Christiaan > wrote: >>> >>> Barry, >>> >>> Thanks for the explanation. >>> >>> We do have some rare cases that give false convergence, but >>> decided to use >>> >>> CALL KSPSetNormType(ksp,KSP_NORM_UNPRECONDITIONED,ierr) >>> >>> so that convergence is always based on the true residual. Our >>> results are much more consistent now. So that could have been >>> your protection against the rare case as well, right? Why do you >>> prefer left preconditioning? >>> >>> Chris >>> >>> >>> >>> dr. ir. Christiaan Klaij | Senior Researcher | Research & Development >>> MARIN | T +31 317 49 33 44 | mailto:C.Klaij at marin.nl | http://www.marin.nl >>> >>> MARIN news: http://www.marin.nl/web/News/News-items/BlueWeek-October-911-Rostock.htm >>> >>> ________________________________________ >>> From: Barry Smith > >>> Sent: Tuesday, August 22, 2017 6:25 PM >>> To: Klaij, Christiaan >>> Cc: petsc-users at mcs.anl.gov >>> Subject: Re: [petsc-users] Petsc ILU PC Change between 3.6.4 and 3.7.x? >>> >>>> On Aug 22, 2017, at 6:49 AM, Klaij, Christiaan > wrote: >>>> >>>> We also faced this problem in our code. So I've added: >>>> >>>> CALL PetscOptionsSetValue(PETSC_NULL_OBJECT,"-sub_pc_factor_shift_type","nonzero",ierr) >>>> >>>> since there seems to be no setter function for this (correct me >>>> if I'm wrong). Then everythings fine again. >>>> >>>> Out of curiosity, what was the reason to change the default >>>> behaviour? >>> >>> The reason we changed this is that we would rather have a failure that makes the user aware of a serious problem then to produce "garbage" results. In some rare cases the shift can cause a huge jump in the preconditioned residual which then decreases rapidly while the true residual does not improve. This results in the KSP thinking it has converged while in fact it has essentially garbage for an answer. Under the previous model, where we shifted by default, users would in this rare case think they had reasonable solutions when they did not. >>> >>> For many users, such as yourself, the previous default behavior was fine because you didn't have the "rare case" but we decided it was best to protect against the rare case even though it would require other users such as yourself to add the option. >>> >>> Barry >> >> >> >> >> -- >> What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. >> -- Norbert Wiener >> >> http://www.caam.rice.edu/~mk51/ -------------- next part -------------- A non-text attachment was scrubbed... Name: signature.asc Type: application/pgp-signature Size: 832 bytes Desc: not available URL: From bsmith at mcs.anl.gov Mon Aug 28 06:46:54 2017 From: bsmith at mcs.anl.gov (Barry Smith) Date: Mon, 28 Aug 2017 06:46:54 -0500 Subject: [petsc-users] A number of questions about DMDA with SNES and Quasi-Newton methods In-Reply-To: References: <020DAED9-AAAD-4741-976B-BB2EF6C79D3F@mcs.anl.gov> <5BF530F6-8D79-47E6-B2C5-B0702FF2AA59@mcs.anl.gov> <7EE84495-4346-4BFB-B9AD-BCAA3C722461@mcs.anl.gov> <08AA1273-062D-4FDD-8709-40AA1FE8AA92@mcs.anl.gov> <06932E72-E8F3-4EA8-889F-A570AD660E32@mcs.anl.gov> Message-ID: > On Aug 28, 2017, at 12:13 AM, zakaryah . wrote: > > Any clues on what I should test with the debugger? Just running with "-snes_type test -snes_test_display -start_in_debugger noxterm" the debugger reports a PETSc error: > > MatSetValues_SeqAIJ(), Inserting a new nonzero at (7,0) in the matrix > > (7,0) is certainly within the allocated space, considering the call to DMDACreate3d() that I sent before. I'm suspicious that the -snes_type test is somehow incompatible with the DMDA, at least without somehow initializing the Jacobian. No definitely not. We use it all the time in many tests and never have problems with new nonzeros. Can you send your code to petsc-maint at mcs.anl.gov and we can run it? Barry From weyenst at gmail.com Mon Aug 28 08:17:50 2017 From: weyenst at gmail.com (Toon Weyens) Date: Mon, 28 Aug 2017 13:17:50 +0000 Subject: [petsc-users] Parallel dense solve with submatrices In-Reply-To: <1683B434-6F43-4682-AEB0-FFFEF48A3470@dsic.upv.es> References: <1683B434-6F43-4682-AEB0-FFFEF48A3470@dsic.upv.es> Message-ID: Very interesting! I might try this afterwards, with H2lib. Also, I must say that the strumpack interface looks promising. What did you mean by "only for the sparse part", by the way? Also, any idea when it is going to be released in an official petsc release, preferably with some documentation? Thanks! On Mon, Aug 28, 2017 at 12:15 PM Jose E. Roman wrote: > > > El 28 ago 2017, a las 10:15, Toon Weyens escribi?: > > > > Thank you Barry, that explains why I couldn't find information about it. > I am now going to implement this straight-forward implementation as a first > step. > > > > In the long term it would in any case be useful to have a solver that > uses H-matrices, such as H2lib. > > > > Is there any chance Petsc is thinking about moving to this kind of > matrices as well in the future? > > > > > > You can use H2lib in a PETSc program by wrapping it in a shell matrix. We > did this some time ago https://doi.org/10.1016/j.cam.2012.07.021 > > Also, PETSc has an interface to STRUMPACK, but only to the sparse part and > I guess what you need is the dense part. > > Jose > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From knepley at gmail.com Mon Aug 28 09:01:31 2017 From: knepley at gmail.com (Matthew Knepley) Date: Mon, 28 Aug 2017 10:01:31 -0400 Subject: [petsc-users] Parallel dense solve with submatrices In-Reply-To: References: <1683B434-6F43-4682-AEB0-FFFEF48A3470@dsic.upv.es> Message-ID: On Mon, Aug 28, 2017 at 9:17 AM, Toon Weyens wrote: > Very interesting! I might try this afterwards, with H2lib. > > Also, I must say that the strumpack interface looks promising. What did > you mean by "only for the sparse part", by the way? Also, any idea when it > is going to be released in an official petsc release, preferably with some > documentation? > I thought STRUMPACK was in 3.7.6 Matt > Thanks! > > On Mon, Aug 28, 2017 at 12:15 PM Jose E. Roman wrote: > >> >> > El 28 ago 2017, a las 10:15, Toon Weyens escribi?: >> > >> > Thank you Barry, that explains why I couldn't find information about >> it. I am now going to implement this straight-forward implementation as a >> first step. >> > >> > In the long term it would in any case be useful to have a solver that >> uses H-matrices, such as H2lib. >> > >> > Is there any chance Petsc is thinking about moving to this kind of >> matrices as well in the future? >> > >> > >> >> You can use H2lib in a PETSc program by wrapping it in a shell matrix. We >> did this some time ago https://doi.org/10.1016/j.cam.2012.07.021 >> >> Also, PETSc has an interface to STRUMPACK, but only to the sparse part >> and I guess what you need is the dense part. >> >> Jose >> >> -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener http://www.caam.rice.edu/~mk51/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From weyenst at gmail.com Mon Aug 28 09:24:07 2017 From: weyenst at gmail.com (Toon Weyens) Date: Mon, 28 Aug 2017 14:24:07 +0000 Subject: [petsc-users] Parallel dense solve with submatrices In-Reply-To: References: <1683B434-6F43-4682-AEB0-FFFEF48A3470@dsic.upv.es> Message-ID: Hey, as indicated here: https://www.mcs.anl.gov/petsc/petsc-dev/docs/manualpages/Mat/MatSTRUMPACKSetHSSMinSize.html there is an example in src/ksp/ksp/examples/tutorials/ex52.c.html However, in my 3.7.6 distribution ex52.c does not have lines 29-31: 29: #if defined(PETSC_HAVE_STRUMPACK) 30: PetscBool flg_strumpack=PETSC_FALSE ; 31: #endif On Mon, Aug 28, 2017 at 4:01 PM Matthew Knepley wrote: > On Mon, Aug 28, 2017 at 9:17 AM, Toon Weyens wrote: > >> Very interesting! I might try this afterwards, with H2lib. >> >> Also, I must say that the strumpack interface looks promising. What did >> you mean by "only for the sparse part", by the way? Also, any idea when it >> is going to be released in an official petsc release, preferably with some >> documentation? >> > > I thought STRUMPACK was in 3.7.6 > > Matt > > >> Thanks! >> >> On Mon, Aug 28, 2017 at 12:15 PM Jose E. Roman >> wrote: >> >>> >>> > El 28 ago 2017, a las 10:15, Toon Weyens escribi?: >>> > >>> > Thank you Barry, that explains why I couldn't find information about >>> it. I am now going to implement this straight-forward implementation as a >>> first step. >>> > >>> > In the long term it would in any case be useful to have a solver that >>> uses H-matrices, such as H2lib. >>> > >>> > Is there any chance Petsc is thinking about moving to this kind of >>> matrices as well in the future? >>> > >>> > >>> >>> You can use H2lib in a PETSc program by wrapping it in a shell matrix. >>> We did this some time ago https://doi.org/10.1016/j.cam.2012.07.021 >>> >>> Also, PETSc has an interface to STRUMPACK, but only to the sparse part >>> and I guess what you need is the dense part. >>> >>> Jose >>> >>> > > > -- > What most experimenters take for granted before they begin their > experiments is infinitely more interesting than any results to which their > experiments lead. > -- Norbert Wiener > > http://www.caam.rice.edu/~mk51/ > -------------- next part -------------- An HTML attachment was scrubbed... URL: From imilian.hartig at gmail.com Mon Aug 28 09:51:04 2017 From: imilian.hartig at gmail.com (Maximilian Hartig) Date: Mon, 28 Aug 2017 16:51:04 +0200 Subject: [petsc-users] accessing fields from previous, converged solution. In-Reply-To: References: <5E7F9366-B000-4F24-9E0B-9CE8BF0FA2E5@gmail.com> <9056F8CB-FAAC-4B63-B498-FDD84C9EC2DF@gmail.com> Message-ID: > On 28. Aug 2017, at 12:31, Matthew Knepley wrote: > > On Mon, Aug 28, 2017 at 5:15 AM, Maximilian Hartig > wrote: > Sorry to bother you again, but I have checked and rechecked my formulation and it corresponds to what I have found in literature. The only difference is that my flow criteria is not evaluated using the trial stress and the current yield stress but rather the corrected stress and the updated yield stress. I am convinced this is what causes the problem. > Unfortunately I do not have any idea on how to go about implementing this. First I don?t know how to access the solution from the past iteration > > I think you can do what you want using > > http://www.mcs.anl.gov/petsc/petsc-master/docs/manualpages/TS/TSSetPostStep.html > > In your function, you would TSGetSolution() and then copy it into an auxiliary vector you > set. This avoids the problem of composition you had before. ok, so now I have a tspoststep function in which I do: TSGetDM(ts, &dm); PetscObjcetQuery((PetscObject) dm, ?A?, (PetscObject*) &copied_solution); TSGetSolution(ts, &solution); VecCopy(solution, copied_solution); but Petsc complains that the vectors have different sizes. I guess this is due to the Dirichlet BC I imposed. I tried imposing the same boundary condition on the auxiliary field which made the vectors the same length. However it seemed to mess up the way auxiliary fields get accessed. Any idea on how I can get the ?full? solution vector where the boundary values are filled in? I tried writing it to a hdf5- file and then calling VecRead on it but I cannot get the hdf5 file format to work. > > and secondly I don?t know how to do the elastic predictor step. > > You can always create another SNES and do a subsolve, maybe in > > http://www.mcs.anl.gov/petsc/petsc-master/docs/manualpages/TS/TSSetPreStep.html#TSSetPreStep That seems very useful as well. Are there any examples for the sub solve? Thanks, Max > > which you then copy into an auxiliary vector, just as above. > > Tell me if I am missing something. > > Thanks, > > Matt > > I tried doing it with auxiliary fields that get updated every timestep but I gather that is not a good idea. Could you please point me in some direction? > > I appreciate you patience with my questioning. > > Thanks, > Max > >> On 22. Aug 2017, at 13:52, Maximilian Hartig > wrote: >> >>> >>> On 17. Aug 2017, at 13:51, Matthew Knepley > wrote: >>> >>> On Thu, Aug 17, 2017 at 3:13 AM, Maximilian Hartig > wrote: >>> Thanks for your help Matt. >>>> On 16. Aug 2017, at 16:17, Matthew Knepley > wrote: >>>> >>>> On Wed, Aug 16, 2017 at 8:56 AM, Maximilian Hartig > wrote: >>>> Hello, >>>> >>>> I have a problem with several fields that I solve with PetscFE and TS. I now need to access the solution from the previous timestep to compute the residual for the current timestep. >>>> I tried a TSMonitor with the following code in it: >>>> >>>> TSGetDM(ts,&dm); >>>> DMClone(dm,&dm_aux); >>>> DMGetDS(dm,&prob_aux); >>>> DMSetDS(dm_aux,prob_aux); >>>> DMCreateGlobalVector(dm_aux,&old_solution); >>>> VecCopy(u,oldsolution); >>>> PetscObjectCompose((PetscObject) dm, ?A?, (PetscObject) old_solution); >>>> >>>> VecDestroy(&old_solution); >>>> DMDestroy(&dm_aux); >>>> >>>> hoping that it would create an auxiliary field that I could access in the evaluation of the residual. It did that but messed with the discretisation of the initial problem in some way. So I figure that adding auxiliary fields to a dm after having fed it to a TS context is not something you should be doing. >>>> >>>> Is there a way to access the fields of the solution for the previous timestep during the evaluation of the current residual? >>>> >>>> First, I can show you how to do what you are asking for. I think you can simply >>>> >>>> PetscObjectQuery((PetscObject) dm, "old_solution", (PetscObject *) &old_solution); >>>> if (!old_solution) { >>>> DMCreateGlobalVector(dm, &old_solution); >>>> PetscObjectCompose((PetscObject) dm, "old_solution", old_solution); >>>> } >>>> VecCopy(u, oldsolution); >>> >>> Unfortunately, this produces an error and tells me ?An object cannot be composed with an object that was composed with it." >>> >>>> >>>> Second, I think a better way to do this than composition is to use >>>> >>>> DMGetNamedGlobalVector(dm, "old_solution", &old_solution); >>> >>> Yes, this seems to work and I do not get an error while running the monitor. Also the discretisation seems to be fine. But the old solution now is not available as an auxiliary field. >>> >>>> >>>> Third, I can say that I am profoundly troubled by this. This interferes with the operation of >>>> the time integrator, and I cannot see a reason for this. If you are keeping track of the integral >>>> of some quantity, I would update that in TSPostStep() and request that integral instead of the >>>> previous solution. We do this for some non-Newtonian rheologies. >>> >>> I have an ?if? condition in my residual which I need to evaluate to determine the correct formulation for my residuals. I use actual fields to keep track of the integrals. But when I use the actual field to evaluate the ?if? condition, due to the implicit nature of the solver I jump ?back and forth? over that condition. I need the ?if? condition to be independent from the field for which it determines the residual. >>> The actual application is as follows: >>> I have, amongst others, a displacement and a stress field. >>> I evaluate for my stress given a displacement increment delta u. >>> If the resulting stress is > yield stress, I need a plasticity formulation, if it is smaller, I can use elasticity. >>> >>> Hmm, I think this is a formulation problem. You should be using the "correct" formulation at the implicit step, since otherwise >>> the residual will be inconsistent with what you tested when evaluated at the new step. I have the same kind of elasto-plastic >>> system in PyLith (http://www.geodynamics.org/cig/software/pylith/ ) which we solve implicitly without much problem. >> >> Possible, but I rechecked the formulation and it looks fine to me. In literature, this kind of algorithm uses an elastic predictor step to determine whether to use the elastic or the plastic formulation. The elastic ?trial? stress is compared with the yield stress from the past timestep. In my current setup, I do not compare the elastic ?trial? stress with the past yield stress but the current stress (including plastic correction) with the current yield stress. I think this is what leads to my problem. When I cheat and just tell petsc to use the plastic formulation from the time on where I expect plastic behaviour, I get convergence and the results look reasonable. >> So I tried to implement a flow condition which would not change during the nonlinear solver iteration steps. If the first, elastic predictor step results in yielding then, in my understanding, from there on we should expect plastic behaviour and not jump ?back and forth? between plastic and elastic behaviour. >> I have taken a look at pylith and it seems to use an explicit formulation for dynamic plasticity. I try to use an implicit formulation solving for displacement, stress, plastic strain and the plastic consistency operator at once. I am not aware of a possibility within the petsc framework to have an internal solver to compute stress state and internal variables depending on the displacement rate and then return to the outer iteration to solve for the correct displacements. This is how I found it done in literature. Is there a possibility to have such an ?internal? snes? >> >> Thanks, >> Max >>> >>> Thanks, >>> >>> Matt >>> >>> Thanks, >>> Max >>> >>>> >>>> Thanks, >>>> >>>> Matt >>>> >>>> Thanks, >>>> Max >>>> >>>> >>>> >>>> -- >>>> What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. >>>> -- Norbert Wiener >>>> >>>> http://www.caam.rice.edu/~mk51/ >>> >>> >>> >>> -- >>> What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. >>> -- Norbert Wiener >>> >>> http://www.caam.rice.edu/~mk51/ > > > > -- > What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. > -- Norbert Wiener > > http://www.caam.rice.edu/~mk51/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From knepley at gmail.com Mon Aug 28 16:04:04 2017 From: knepley at gmail.com (Matthew Knepley) Date: Mon, 28 Aug 2017 17:04:04 -0400 Subject: [petsc-users] accessing fields from previous, converged solution. In-Reply-To: References: <5E7F9366-B000-4F24-9E0B-9CE8BF0FA2E5@gmail.com> <9056F8CB-FAAC-4B63-B498-FDD84C9EC2DF@gmail.com> Message-ID: On Mon, Aug 28, 2017 at 10:51 AM, Maximilian Hartig < imilian.hartig at gmail.com> wrote: > > On 28. Aug 2017, at 12:31, Matthew Knepley wrote: > > On Mon, Aug 28, 2017 at 5:15 AM, Maximilian Hartig com> wrote: > >> Sorry to bother you again, but I have checked and rechecked my >> formulation and it corresponds to what I have found in literature. The only >> difference is that my flow criteria is not evaluated using the trial stress >> and the current yield stress but rather the corrected stress and the >> updated yield stress. I am convinced this is what causes the problem. >> Unfortunately I do not have any idea on how to go about implementing >> this. First I don?t know how to access the solution from the past iteration >> > > I think you can do what you want using > > http://www.mcs.anl.gov/petsc/petsc-master/docs/ > manualpages/TS/TSSetPostStep.html > > In your function, you would TSGetSolution() and then copy it into an > auxiliary vector you > set. This avoids the problem of composition you had before. > > > ok, so now I have a tspoststep function in which I do: > > TSGetDM(ts, &dm); > PetscObjcetQuery((PetscObject) dm, ?A?, (PetscObject*) &copied_solution); > TSGetSolution(ts, &solution); > VecCopy(solution, copied_solution); > > but Petsc complains that the vectors have different sizes. I guess this is > due to the Dirichlet BC I imposed. > Okay, this should be better documented. The auxiliary fields are all local vectors. This makes it easy to project them to any cell. It means that above you will replace VecCopy with DMGlobalToLocalBegin(dm, solution, copied_solution); DMGlobalToLocalEnd(dm, solution, copied_solution); and you will need a local vector for copied_solution. Sorry bout that. > I tried imposing the same boundary condition on the auxiliary field which > made the vectors the same length. However it seemed to mess up the way > auxiliary fields get accessed. Any idea on how I can get the ?full? > solution vector where the boundary values are filled in? I tried writing it > to a hdf5- file and then calling VecRead on it but I cannot get the hdf5 > file format to work. > > > >> and secondly I don?t know how to do the elastic predictor step. >> > > You can always create another SNES and do a subsolve, maybe in > > http://www.mcs.anl.gov/petsc/petsc-master/docs/ > manualpages/TS/TSSetPreStep.html#TSSetPreStep > > That seems very useful as well. Are there any examples for the sub solve? > There is one in PyLith (dynamic fault friction), but I cannot think of one in the PETSc examples right now. Thanks, Matt > Thanks, > Max > > > which you then copy into an auxiliary vector, just as above. > > Tell me if I am missing something. > > Thanks, > > Matt > > >> I tried doing it with auxiliary fields that get updated every timestep >> but I gather that is not a good idea. Could you please point me in some >> direction? >> >> I appreciate you patience with my questioning. >> >> Thanks, >> Max >> >> On 22. Aug 2017, at 13:52, Maximilian Hartig >> wrote: >> >> >> On 17. Aug 2017, at 13:51, Matthew Knepley wrote: >> >> On Thu, Aug 17, 2017 at 3:13 AM, Maximilian Hartig < >> imilian.hartig at gmail.com> wrote: >> >>> Thanks for your help Matt. >>> >>> On 16. Aug 2017, at 16:17, Matthew Knepley wrote: >>> >>> On Wed, Aug 16, 2017 at 8:56 AM, Maximilian Hartig < >>> imilian.hartig at gmail.com> wrote: >>> >>>> Hello, >>>> >>>> I have a problem with several fields that I solve with PetscFE and TS. >>>> I now need to access the solution from the previous timestep to compute the >>>> residual for the current timestep. >>>> I tried a TSMonitor with the following code in it: >>>> >>>> TSGetDM(ts,&dm); >>>> DMClone(dm,&dm_aux); >>>> DMGetDS(dm,&prob_aux); >>>> DMSetDS(dm_aux,prob_aux); >>>> DMCreateGlobalVector(dm_aux,&old_solution); >>>> VecCopy(u,oldsolution); >>>> PetscObjectCompose((PetscObject) dm, ?A?, (PetscObject) old_solution); >>>> >>>> VecDestroy(&old_solution); >>>> DMDestroy(&dm_aux); >>>> >>>> hoping that it would create an auxiliary field that I could access in >>>> the evaluation of the residual. It did that but messed with the >>>> discretisation of the initial problem in some way. So I figure that adding >>>> auxiliary fields to a dm after having fed it to a TS context is not >>>> something you should be doing. >>>> >>>> Is there a way to access the fields of the solution for the previous >>>> timestep during the evaluation of the current residual? >>>> >>> >>> First, I can show you how to do what you are asking for. I think you can >>> simply >>> >>> PetscObjectQuery((PetscObject) dm, "old_solution", (PetscObject *) >>> &old_solution); >>> if (!old_solution) { >>> DMCreateGlobalVector(dm, &old_solution); >>> PetscObjectCompose((PetscObject) dm, "old_solution", old_solution); >>> } >>> VecCopy(u, oldsolution); >>> >>> >>> Unfortunately, this produces an error and tells me ?An object cannot be >>> composed with an object that was composed with it." >>> >>> >>> Second, I think a better way to do this than composition is to use >>> >>> DMGetNamedGlobalVector(dm, "old_solution", &old_solution); >>> >>> >>> Yes, this seems to work and I do not get an error while running the >>> monitor. Also the discretisation seems to be fine. But the old solution now >>> is not available as an auxiliary field. >>> >>> >>> Third, I can say that I am profoundly troubled by this. This interferes >>> with the operation of >>> the time integrator, and I cannot see a reason for this. If you are >>> keeping track of the integral >>> of some quantity, I would update that in TSPostStep() and request that >>> integral instead of the >>> previous solution. We do this for some non-Newtonian rheologies. >>> >>> >>> I have an ?if? condition in my residual which I need to evaluate to >>> determine the correct formulation for my residuals. I use actual fields to >>> keep track of the integrals. But when I use the actual field to evaluate >>> the ?if? condition, due to the implicit nature of the solver I jump ?back >>> and forth? over that condition. I need the ?if? condition to be independent >>> from the field for which it determines the residual. >>> The actual application is as follows: >>> I have, amongst others, a displacement and a stress field. >>> I evaluate for my stress given a displacement increment delta u. >>> If the resulting stress is > yield stress, I need a plasticity >>> formulation, if it is smaller, I can use elasticity. >>> >> >> Hmm, I think this is a formulation problem. You should be using the >> "correct" formulation at the implicit step, since otherwise >> the residual will be inconsistent with what you tested when evaluated at >> the new step. I have the same kind of elasto-plastic >> system in PyLith (http://www.geodynamics.org/cig/software/pylith/) which >> we solve implicitly without much problem. >> >> >> Possible, but I rechecked the formulation and it looks fine to me. In >> literature, this kind of algorithm uses an elastic predictor step to >> determine whether to use the elastic or the plastic formulation. The >> elastic ?trial? stress is compared with the yield stress from the past >> timestep. In my current setup, I do not compare the elastic ?trial? stress >> with the past yield stress but the current stress (including plastic >> correction) with the current yield stress. I think this is what leads to my >> problem. When I cheat and just tell petsc to use the plastic formulation >> from the time on where I expect plastic behaviour, I get convergence and >> the results look reasonable. >> So I tried to implement a flow condition which would not change during >> the nonlinear solver iteration steps. If the first, elastic predictor step >> results in yielding then, in my understanding, from there on we should >> expect plastic behaviour and not jump ?back and forth? between plastic and >> elastic behaviour. >> I have taken a look at pylith and it seems to use an explicit formulation >> for dynamic plasticity. I try to use an implicit formulation solving for >> displacement, stress, plastic strain and the plastic consistency operator >> at once. I am not aware of a possibility within the petsc framework to have >> an internal solver to compute stress state and internal variables depending >> on the displacement rate and then return to the outer iteration to solve >> for the correct displacements. This is how I found it done in literature. >> Is there a possibility to have such an ?internal? snes? >> >> Thanks, >> Max >> >> >> Thanks, >> >> Matt >> >> >>> Thanks, >>> Max >>> >>> >>> Thanks, >>> >>> Matt >>> >>> >>>> Thanks, >>>> Max >>> >>> >>> >>> >>> -- >>> What most experimenters take for granted before they begin their >>> experiments is infinitely more interesting than any results to which their >>> experiments lead. >>> -- Norbert Wiener >>> >>> http://www.caam.rice.edu/~mk51/ >>> >>> >>> >> >> >> -- >> What most experimenters take for granted before they begin their >> experiments is infinitely more interesting than any results to which their >> experiments lead. >> -- Norbert Wiener >> >> http://www.caam.rice.edu/~mk51/ >> >> >> > > > -- > What most experimenters take for granted before they begin their > experiments is infinitely more interesting than any results to which their > experiments lead. > -- Norbert Wiener > > http://www.caam.rice.edu/~mk51/ > > > -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener http://www.caam.rice.edu/~mk51/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From knepley at gmail.com Mon Aug 28 16:10:03 2017 From: knepley at gmail.com (Matthew Knepley) Date: Mon, 28 Aug 2017 17:10:03 -0400 Subject: [petsc-users] Parallel dense solve with submatrices In-Reply-To: References: <1683B434-6F43-4682-AEB0-FFFEF48A3470@dsic.upv.es> Message-ID: Hi Sherry, Did you guys have a standard PETSc example that you run to test the interface? Should I be asking someone else? Thanks, Matt On Mon, Aug 28, 2017 at 10:24 AM, Toon Weyens wrote: > Hey, as indicated here: https://www.mcs.anl.gov/petsc/petsc-dev/docs/ > manualpages/Mat/MatSTRUMPACKSetHSSMinSize.html > > there is an example in src/ksp/ksp/examples/tutorials/ex52.c.html > > > However, in my 3.7.6 distribution ex52.c does not have lines 29-31: > > 29: #if defined(PETSC_HAVE_STRUMPACK) 30: PetscBool flg_strumpack=PETSC_FALSE ; 31: #endif > > > On Mon, Aug 28, 2017 at 4:01 PM Matthew Knepley wrote: > >> On Mon, Aug 28, 2017 at 9:17 AM, Toon Weyens wrote: >> >>> Very interesting! I might try this afterwards, with H2lib. >>> >>> Also, I must say that the strumpack interface looks promising. What did >>> you mean by "only for the sparse part", by the way? Also, any idea when it >>> is going to be released in an official petsc release, preferably with some >>> documentation? >>> >> >> I thought STRUMPACK was in 3.7.6 >> >> Matt >> >> >>> Thanks! >>> >>> On Mon, Aug 28, 2017 at 12:15 PM Jose E. Roman >>> wrote: >>> >>>> >>>> > El 28 ago 2017, a las 10:15, Toon Weyens >>>> escribi?: >>>> > >>>> > Thank you Barry, that explains why I couldn't find information about >>>> it. I am now going to implement this straight-forward implementation as a >>>> first step. >>>> > >>>> > In the long term it would in any case be useful to have a solver that >>>> uses H-matrices, such as H2lib. >>>> > >>>> > Is there any chance Petsc is thinking about moving to this kind of >>>> matrices as well in the future? >>>> > >>>> > >>>> >>>> You can use H2lib in a PETSc program by wrapping it in a shell matrix. >>>> We did this some time ago https://doi.org/10.1016/j.cam.2012.07.021 >>>> >>>> Also, PETSc has an interface to STRUMPACK, but only to the sparse part >>>> and I guess what you need is the dense part. >>>> >>>> Jose >>>> >>>> >> >> >> -- >> What most experimenters take for granted before they begin their >> experiments is infinitely more interesting than any results to which their >> experiments lead. >> -- Norbert Wiener >> >> http://www.caam.rice.edu/~mk51/ >> > -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener http://www.caam.rice.edu/~mk51/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From zakaryah at gmail.com Mon Aug 28 20:21:49 2017 From: zakaryah at gmail.com (zakaryah .) Date: Mon, 28 Aug 2017 21:21:49 -0400 Subject: [petsc-users] A number of questions about DMDA with SNES and Quasi-Newton methods In-Reply-To: References: <020DAED9-AAAD-4741-976B-BB2EF6C79D3F@mcs.anl.gov> <5BF530F6-8D79-47E6-B2C5-B0702FF2AA59@mcs.anl.gov> <7EE84495-4346-4BFB-B9AD-BCAA3C722461@mcs.anl.gov> <08AA1273-062D-4FDD-8709-40AA1FE8AA92@mcs.anl.gov> <06932E72-E8F3-4EA8-889F-A570AD660E32@mcs.anl.gov> Message-ID: OK - I'll just mention that I'm getting really bizarre behavior with the debugger. I compiled with -g -O0 (and same for PETSc library, using COPTFLAGS, CXXOPTFLAGS, and FOPTFLAGS). The strange behavior includes: I set a breakpoint in the Jacobian evaluation function, and when stepping with gdb, the executed line doesn't match the code at all. Instead, it jumps forwards and backwards. Variables which are assigned a value at the beginning of the routine are later set to zero. Variables defined outside of the routine (for example, variables pointed to by my external parameters ctx) remain correctly valued. When I run the code with -snes_test_display, many of the elements of the Jacobian show as zero in the hand-coded routine, while the finite difference shows correct values. When I step through the Jacobian evaluation function with the debugger, the corresponding values are calculated correctly, i.e. they match the values from the finite difference. To me this looks like a memory leak in the Jacobian evaluation routine, although valgrind doesn't catch anything and neither does gdb. I'll take your advice and upload the code to the maint list - thanks for all your help! On Mon, Aug 28, 2017 at 7:46 AM, Barry Smith wrote: > > > On Aug 28, 2017, at 12:13 AM, zakaryah . wrote: > > > > Any clues on what I should test with the debugger? Just running with > "-snes_type test -snes_test_display -start_in_debugger noxterm" the > debugger reports a PETSc error: > > > > MatSetValues_SeqAIJ(), Inserting a new nonzero at (7,0) in the matrix > > > > (7,0) is certainly within the allocated space, considering the call to > DMDACreate3d() that I sent before. I'm suspicious that the -snes_type test > is somehow incompatible with the DMDA, at least without somehow > initializing the Jacobian. > > No definitely not. We use it all the time in many tests and never have > problems with new nonzeros. Can you send your code to > petsc-maint at mcs.anl.gov and we can run it? > > Barry > > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From bcyee at umich.edu Tue Aug 29 18:19:52 2017 From: bcyee at umich.edu (Ben Yee) Date: Tue, 29 Aug 2017 19:19:52 -0400 Subject: [petsc-users] Red-black block Jacobi in PETSc? Message-ID: Hi, For the smoother in PCMG, I want to use a red-black block Jacobi smoother. Is this available with the existing PETSc options? If so, how do I designate which blocks are red and which are black? If it is not possible, what would be the best way to implement this? Would I use KSPRICHARDSON+PCSHELL? Thanks! -- Ben Yee NERS PhD Candidate, University of Michigan B.S. Mech. & Nuclear Eng., U.C. Berkeley -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Tue Aug 29 18:33:40 2017 From: bsmith at mcs.anl.gov (Barry Smith) Date: Tue, 29 Aug 2017 18:33:40 -0500 Subject: [petsc-users] Red-black block Jacobi in PETSc? In-Reply-To: References: Message-ID: Ben, Please explain more what you mean by "a red-black block Jacobi smoother". What is your matrix structure? What are the blocks? How do you decide which ones are which color? Why do you wish to use some a smoother. Barry > On Aug 29, 2017, at 6:19 PM, Ben Yee wrote: > > Hi, > > For the smoother in PCMG, I want to use a red-black block Jacobi smoother. Is this available with the existing PETSc options? If so, how do I designate which blocks are red and which are black? > > If it is not possible, what would be the best way to implement this? Would I use KSPRICHARDSON+PCSHELL? > > Thanks! > > -- > Ben Yee > > NERS PhD Candidate, University of Michigan > B.S. Mech. & Nuclear Eng., U.C. Berkeley From bcyee at umich.edu Tue Aug 29 18:47:14 2017 From: bcyee at umich.edu (Ben Yee) Date: Tue, 29 Aug 2017 19:47:14 -0400 Subject: [petsc-users] Red-black block Jacobi in PETSc? In-Reply-To: References: Message-ID: I'm solving a coupled set of equations, so each "block" corresponds to a set of unknowns for a particular spatial cell. The matrix is structured such that all of the unknowns for a given spatial cell have adjacent global matrix indices (i.e., they're next to each other in the global solution vector). Effectively, I want to do red-black Gauss Seidel, but with blocks. Alternatively, it's the same as applying block Jacobi for all the red cells and then applying block Jacobi for all the black cells. The color of the block is determined from the geometry of the problem which is stored in various structures in the code I'm working on, independent of petsc. (Physically, I generally have a nice 3d cartesian spatial grid and the coloring is just a checkerboard in that case.) The reason I want to do this is for research purposes. I've implemented my own interpolation matrices for PCMG, and, in my simpler 1d codes and convergence analyses, I've found that doing a red-black smoothing significantly improved convergence for my particular problem (though I'm aware that this generally leads to poor cache efficiency). On Aug 29, 2017 7:33 PM, "Barry Smith" wrote: Ben, Please explain more what you mean by "a red-black block Jacobi smoother". What is your matrix structure? What are the blocks? How do you decide which ones are which color? Why do you wish to use some a smoother. Barry > On Aug 29, 2017, at 6:19 PM, Ben Yee wrote: > > Hi, > > For the smoother in PCMG, I want to use a red-black block Jacobi smoother. Is this available with the existing PETSc options? If so, how do I designate which blocks are red and which are black? > > If it is not possible, what would be the best way to implement this? Would I use KSPRICHARDSON+PCSHELL? > > Thanks! > > -- > Ben Yee > > NERS PhD Candidate, University of Michigan > B.S. Mech. & Nuclear Eng., U.C. Berkeley -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Tue Aug 29 20:11:19 2017 From: bsmith at mcs.anl.gov (Barry Smith) Date: Tue, 29 Aug 2017 20:11:19 -0500 Subject: [petsc-users] Red-black block Jacobi in PETSc? In-Reply-To: References: Message-ID: Ok, you should be using the BAIJ matrix it supports point-block Jacobi and point-block Gauss-Seidel. We do not have a red-black Jacobi/Gauss-Seidel but you could easily add it. You will add it, not by using a any shell objects but by adding functionality to the PCPBJACOBI code in PETSc which is in src/ksp/pc/impls/pbjacobi/pbjacobi.c First you will need to add a routine to supply the colors (make it general for any number of colors since the code is basically the same as for only two colors) call it say PCPBJacobiSetColors(PC pc,PetscInt number of colors, PetscInt *sizeofeachcolor, PetscInt **idsforeachcolor); you will have to add additional fields in PC_PBJacobi to contain this information. Then copy the static PetscErrorCode PCApply_PBJacobi_N(PC pc,Vec x,Vec y) for your block size N (for example 3) and modify it to do what you want, so for example static PetscErrorCode PCApply_PBJacobi_2_Color(PC pc,Vec x,Vec y) { PC_PBJacobi *jac = (PC_PBJacobi*)pc->data; PetscErrorCode ierr; PetscInt i,m = jac->mbs; const MatScalar *diag = jac->diag; PetscScalar x0,x1,*yy; const PetscScalar *xx; PetscFunctionBegin; if (!jac->b) { ierr = VecDuplicate(x,&jac->b); ierr = VecDuplicate(x,&jac->work); } ierr = VecCopy(x,b);CHKERRQ(ierr); for (j=0; jnumberofcolors; j++) { ierr = VecGetArrayRead(b,&xx);CHKERRQ(ierr); ierr = VecGetArray(y,&yy);CHKERRQ(ierr); for (i=0; isizeofeachcolor[j]; i++) { ii = jac->idsforeachcolor[j][i]; diag = jac->diag + 4*ii; x0 = xx[2*ii]; x1 = xx[2*ii+1]; yy[2*ii] = diag[0]*x0 + diag[2]*x1; yy[2*ii+1] = diag[1]*x0 + diag[3]*x1; } ierr = VecRestoreArrayRead(b,&xx);CHKERRQ(ierr); ierr = VecRestoreArray(y,&yy);CHKERRQ(ierr); /* update residual */ if (i < jac->sizeofeachcolor[j]-1) { ierr = MatMult(pc->matrix,y,work2); ierr = VecAYPX(b,-1,work1); } } PetscFunctionReturn(0); } Finally in PCSetUp_PBJacobi() you would set the apply function pointer to the "color" version if the user has provided the coloring information. Pretty simple. Barry > On Aug 29, 2017, at 6:47 PM, Ben Yee wrote: > > I'm solving a coupled set of equations, so each "block" corresponds to a set of unknowns for a particular spatial cell. The matrix is structured such that all of the unknowns for a given spatial cell have adjacent global matrix indices (i.e., they're next to each other in the global solution vector). Effectively, I want to do red-black Gauss Seidel, but with blocks. Alternatively, it's the same as applying block Jacobi for all the red cells and then applying block Jacobi for all the black cells. > > The color of the block is determined from the geometry of the problem which is stored in various structures in the code I'm working on, independent of petsc. (Physically, I generally have a nice 3d cartesian spatial grid and the coloring is just a checkerboard in that case.) > > The reason I want to do this is for research purposes. I've implemented my own interpolation matrices for PCMG, and, in my simpler 1d codes and convergence analyses, I've found that doing a red-black smoothing significantly improved convergence for my particular problem (though I'm aware that this generally leads to poor cache efficiency). > > On Aug 29, 2017 7:33 PM, "Barry Smith" wrote: > > Ben, > > Please explain more what you mean by "a red-black block Jacobi smoother". What is your matrix structure? What are the blocks? How do you decide which ones are which color? Why do you wish to use some a smoother. > > Barry > > > On Aug 29, 2017, at 6:19 PM, Ben Yee wrote: > > > > Hi, > > > > For the smoother in PCMG, I want to use a red-black block Jacobi smoother. Is this available with the existing PETSc options? If so, how do I designate which blocks are red and which are black? > > > > If it is not possible, what would be the best way to implement this? Would I use KSPRICHARDSON+PCSHELL? > > > > Thanks! > > > > -- > > Ben Yee > > > > NERS PhD Candidate, University of Michigan > > B.S. Mech. & Nuclear Eng., U.C. Berkeley > > From bcyee at umich.edu Tue Aug 29 21:10:31 2017 From: bcyee at umich.edu (Ben Yee) Date: Tue, 29 Aug 2017 22:10:31 -0400 Subject: [petsc-users] Red-black block Jacobi in PETSc? In-Reply-To: References: Message-ID: Thank you for your detailed response! In my case, the number of equations (the block size) depends on the user input (there is one equation per energy group, and the number of groups depends on how the user wants to discretize the energy variable). It typically is around 50, but can be as high as a few hundred. In pbjacobi.c, it seems that it is hard-coded to work for a fixed block size N, but I would like it to work for general N. Moreover, I would like to solve the blocks iteratively (using SOR for example) since the block sizes can get rather large. I haven't tried this yet, but it seems that it wouldn't be too hard to modify what you have suggested to work as I have described above. I could add an extra PetscBool to pbjacobi that indicates that I want to use my own PCApply_PBJacobi which would work for general block size N. And, in that function, instead of applying a stored inverse block, I could implement SOR iterations. Does that sound like a good plan, or do you suggest an alternative approach? Thanks again for your help on this! On Tue, Aug 29, 2017 at 9:11 PM, Barry Smith wrote: > > Ok, you should be using the BAIJ matrix it supports point-block Jacobi > and point-block Gauss-Seidel. > > We do not have a red-black Jacobi/Gauss-Seidel but you could easily add > it. You will add it, not by using a any shell objects but by adding > functionality to the PCPBJACOBI code in PETSc which is in > src/ksp/pc/impls/pbjacobi/pbjacobi.c > > First you will need to add a routine to supply the colors (make it > general for any number of colors since the code is basically the same as > for only two colors) call it say > > PCPBJacobiSetColors(PC pc,PetscInt number of colors, PetscInt > *sizeofeachcolor, PetscInt **idsforeachcolor); > > you will have to add additional fields in PC_PBJacobi to contain this > information. > > Then copy the static PetscErrorCode PCApply_PBJacobi_N(PC pc,Vec x,Vec > y) for your block size N (for example 3) and modify it to do what you > want, so for example > > static PetscErrorCode PCApply_PBJacobi_2_Color(PC pc,Vec x,Vec y) > { > PC_PBJacobi *jac = (PC_PBJacobi*)pc->data; > PetscErrorCode ierr; > PetscInt i,m = jac->mbs; > const MatScalar *diag = jac->diag; > PetscScalar x0,x1,*yy; > const PetscScalar *xx; > > PetscFunctionBegin; > if (!jac->b) { > ierr = VecDuplicate(x,&jac->b); > ierr = VecDuplicate(x,&jac->work); > } > > ierr = VecCopy(x,b);CHKERRQ(ierr); > for (j=0; jnumberofcolors; j++) { > > ierr = VecGetArrayRead(b,&xx);CHKERRQ(ierr); > ierr = VecGetArray(y,&yy);CHKERRQ(ierr); > > for (i=0; isizeofeachcolor[j]; i++) { > ii = jac->idsforeachcolor[j][i]; > diag = jac->diag + 4*ii; > x0 = xx[2*ii]; x1 = xx[2*ii+1]; > yy[2*ii] = diag[0]*x0 + diag[2]*x1; > yy[2*ii+1] = diag[1]*x0 + diag[3]*x1; > } > ierr = VecRestoreArrayRead(b,&xx);CHKERRQ(ierr); > ierr = VecRestoreArray(y,&yy);CHKERRQ(ierr); > > /* update residual */ > if (i < jac->sizeofeachcolor[j]-1) { > ierr = MatMult(pc->matrix,y,work2); > ierr = VecAYPX(b,-1,work1); > } > } > > PetscFunctionReturn(0); > } > > Finally in PCSetUp_PBJacobi() you would set the apply function pointer > to the "color" version if the user has provided the coloring information. > > Pretty simple. > > Barry > > > > On Aug 29, 2017, at 6:47 PM, Ben Yee wrote: > > > > I'm solving a coupled set of equations, so each "block" corresponds to a > set of unknowns for a particular spatial cell. The matrix is structured > such that all of the unknowns for a given spatial cell have adjacent global > matrix indices (i.e., they're next to each other in the global solution > vector). Effectively, I want to do red-black Gauss Seidel, but with > blocks. Alternatively, it's the same as applying block Jacobi for all the > red cells and then applying block Jacobi for all the black cells. > > > > The color of the block is determined from the geometry of the problem > which is stored in various structures in the code I'm working on, > independent of petsc. (Physically, I generally have a nice 3d cartesian > spatial grid and the coloring is just a checkerboard in that case.) > > > > The reason I want to do this is for research purposes. I've implemented > my own interpolation matrices for PCMG, and, in my simpler 1d codes and > convergence analyses, I've found that doing a red-black smoothing > significantly improved convergence for my particular problem (though I'm > aware that this generally leads to poor cache efficiency). > > > > On Aug 29, 2017 7:33 PM, "Barry Smith" wrote: > > > > Ben, > > > > Please explain more what you mean by "a red-black block Jacobi > smoother". What is your matrix structure? What are the blocks? How do you > decide which ones are which color? Why do you wish to use some a smoother. > > > > Barry > > > > > On Aug 29, 2017, at 6:19 PM, Ben Yee wrote: > > > > > > Hi, > > > > > > For the smoother in PCMG, I want to use a red-black block Jacobi > smoother. Is this available with the existing PETSc options? If so, how > do I designate which blocks are red and which are black? > > > > > > If it is not possible, what would be the best way to implement this? > Would I use KSPRICHARDSON+PCSHELL? > > > > > > Thanks! > > > > > > -- > > > Ben Yee > > > > > > NERS PhD Candidate, University of Michigan > > > B.S. Mech. & Nuclear Eng., U.C. Berkeley > > > > > > -- Ben Yee NERS PhD Candidate, University of Michigan B.S. Mech. & Nuclear Eng., U.C. Berkeley -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Tue Aug 29 21:32:17 2017 From: bsmith at mcs.anl.gov (Barry Smith) Date: Tue, 29 Aug 2017 21:32:17 -0500 Subject: [petsc-users] Red-black block Jacobi in PETSc? In-Reply-To: References: Message-ID: > On Aug 29, 2017, at 9:10 PM, Ben Yee wrote: > > Thank you for your detailed response! > > In my case, the number of equations (the block size) depends on the user input (there is one equation per energy group, and the number of groups depends on how the user wants to discretize the energy variable). It typically is around 50, but can be as high as a few hundred. In pbjacobi.c, it seems that it is hard-coded to work for a fixed block size N, but I would like it to work for general N. Moreover, I would like to solve the blocks iteratively (using SOR for example) since the block sizes can get rather large. > > I haven't tried this yet, but it seems that it wouldn't be too hard to modify what you have suggested to work as I have described above. I could add an extra PetscBool to pbjacobi that indicates that I want to use my own PCApply_PBJacobi which would work for general block size N. And, in that function, instead of applying a stored inverse block, I could implement SOR iterations. There is a general PCApply_PBJacobi_N() you can start with no need for a bool. Almost for sure if the blocks are more than 30% full you will do better to to do the factorization and inversion and NOT do SOR. How dense are your blocks? I am assuming each block is of the same size? Barry > > Does that sound like a good plan, or do you suggest an alternative approach? > > Thanks again for your help on this! > > On Tue, Aug 29, 2017 at 9:11 PM, Barry Smith wrote: > > Ok, you should be using the BAIJ matrix it supports point-block Jacobi and point-block Gauss-Seidel. > > We do not have a red-black Jacobi/Gauss-Seidel but you could easily add it. You will add it, not by using a any shell objects but by adding functionality to the PCPBJACOBI code in PETSc which is in src/ksp/pc/impls/pbjacobi/pbjacobi.c > > First you will need to add a routine to supply the colors (make it general for any number of colors since the code is basically the same as for only two colors) call it say > > PCPBJacobiSetColors(PC pc,PetscInt number of colors, PetscInt *sizeofeachcolor, PetscInt **idsforeachcolor); > > you will have to add additional fields in PC_PBJacobi to contain this information. > > Then copy the static PetscErrorCode PCApply_PBJacobi_N(PC pc,Vec x,Vec y) for your block size N (for example 3) and modify it to do what you want, so for example > > static PetscErrorCode PCApply_PBJacobi_2_Color(PC pc,Vec x,Vec y) > { > PC_PBJacobi *jac = (PC_PBJacobi*)pc->data; > PetscErrorCode ierr; > PetscInt i,m = jac->mbs; > const MatScalar *diag = jac->diag; > PetscScalar x0,x1,*yy; > const PetscScalar *xx; > > PetscFunctionBegin; > if (!jac->b) { > ierr = VecDuplicate(x,&jac->b); > ierr = VecDuplicate(x,&jac->work); > } > > ierr = VecCopy(x,b);CHKERRQ(ierr); > for (j=0; jnumberofcolors; j++) { > > ierr = VecGetArrayRead(b,&xx);CHKERRQ(ierr); > ierr = VecGetArray(y,&yy);CHKERRQ(ierr); > > for (i=0; isizeofeachcolor[j]; i++) { > ii = jac->idsforeachcolor[j][i]; > diag = jac->diag + 4*ii; > x0 = xx[2*ii]; x1 = xx[2*ii+1]; > yy[2*ii] = diag[0]*x0 + diag[2]*x1; > yy[2*ii+1] = diag[1]*x0 + diag[3]*x1; > } > ierr = VecRestoreArrayRead(b,&xx);CHKERRQ(ierr); > ierr = VecRestoreArray(y,&yy);CHKERRQ(ierr); > > /* update residual */ > if (i < jac->sizeofeachcolor[j]-1) { > ierr = MatMult(pc->matrix,y,work2); > ierr = VecAYPX(b,-1,work1); > } > } > > PetscFunctionReturn(0); > } > > Finally in PCSetUp_PBJacobi() you would set the apply function pointer to the "color" version if the user has provided the coloring information. > > Pretty simple. > > Barry > > > > On Aug 29, 2017, at 6:47 PM, Ben Yee wrote: > > > > I'm solving a coupled set of equations, so each "block" corresponds to a set of unknowns for a particular spatial cell. The matrix is structured such that all of the unknowns for a given spatial cell have adjacent global matrix indices (i.e., they're next to each other in the global solution vector). Effectively, I want to do red-black Gauss Seidel, but with blocks. Alternatively, it's the same as applying block Jacobi for all the red cells and then applying block Jacobi for all the black cells. > > > > The color of the block is determined from the geometry of the problem which is stored in various structures in the code I'm working on, independent of petsc. (Physically, I generally have a nice 3d cartesian spatial grid and the coloring is just a checkerboard in that case.) > > > > The reason I want to do this is for research purposes. I've implemented my own interpolation matrices for PCMG, and, in my simpler 1d codes and convergence analyses, I've found that doing a red-black smoothing significantly improved convergence for my particular problem (though I'm aware that this generally leads to poor cache efficiency). > > > > On Aug 29, 2017 7:33 PM, "Barry Smith" wrote: > > > > Ben, > > > > Please explain more what you mean by "a red-black block Jacobi smoother". What is your matrix structure? What are the blocks? How do you decide which ones are which color? Why do you wish to use some a smoother. > > > > Barry > > > > > On Aug 29, 2017, at 6:19 PM, Ben Yee wrote: > > > > > > Hi, > > > > > > For the smoother in PCMG, I want to use a red-black block Jacobi smoother. Is this available with the existing PETSc options? If so, how do I designate which blocks are red and which are black? > > > > > > If it is not possible, what would be the best way to implement this? Would I use KSPRICHARDSON+PCSHELL? > > > > > > Thanks! > > > > > > -- > > > Ben Yee > > > > > > NERS PhD Candidate, University of Michigan > > > B.S. Mech. & Nuclear Eng., U.C. Berkeley > > > > > > > > > -- > Ben Yee > > NERS PhD Candidate, University of Michigan > B.S. Mech. & Nuclear Eng., U.C. Berkeley From zakaryah at gmail.com Tue Aug 29 21:49:33 2017 From: zakaryah at gmail.com (zakaryah .) Date: Tue, 29 Aug 2017 22:49:33 -0400 Subject: [petsc-users] A number of questions about DMDA with SNES and Quasi-Newton methods In-Reply-To: References: <020DAED9-AAAD-4741-976B-BB2EF6C79D3F@mcs.anl.gov> <5BF530F6-8D79-47E6-B2C5-B0702FF2AA59@mcs.anl.gov> <7EE84495-4346-4BFB-B9AD-BCAA3C722461@mcs.anl.gov> <08AA1273-062D-4FDD-8709-40AA1FE8AA92@mcs.anl.gov> <06932E72-E8F3-4EA8-889F-A570AD660E32@mcs.anl.gov> Message-ID: I figured out the cause of my problems with the debugger and the Jacobian evaluation - I had a silly memory corruption issue which is now fixed. I am still having trouble with convergence. I am using a test problem of intermediate size, which has nearly identical Jacobians when comparing finite difference to hand-coded. If I run with -snes_type newtonls -snes_monitor -ksp_monitor -ksp_ksp_monitor -ksp_monitor_true_residual -ksp_converged_reason -snes_converged_reason, the very first SNES iteration fails to converge, due to the KSP failing to converge after 10,000 iterations. Following the "Why is my iterative solver not converging?" FAQ, I ran the problem on an even smaller grid, with -snes_type newtonls -snes_monitor -ksp_monitor -ksp_ksp_monitor -ksp_monitor_true_residual -ksp_converged_reason -snes_converged_reason -pc_type svd -pc_svd_monitor, and the linear system was not close to singular. I don't have any reason to suspect that the linear system becomes more singular as the grid size increases. Next, I ran with -snes_type newtonls -snes_monitor -ksp_monitor -ksp_ksp_monitor -ksp_monitor_true_residual -ksp_converged_reason -snes_converged_reason -ksp_gmres_restart 1000 -pc_type none, and the KSP seemed to converge better, but the SNES only ran for a few iterations before it stopped with "Nonlinear solve did not converge due to DIVERGED_LINE_SEARCH iterations 7". ?Can I conclude from this that running the KSP without a pre-conditioner ?is a good idea? At that point, should I go back to asking why the SNES doesn't converge, ala the "Why is Newton's method not converging?" FAQ? Thanks for the continuing help! -------------- next part -------------- An HTML attachment was scrubbed... URL: From bcyee at umich.edu Tue Aug 29 21:54:18 2017 From: bcyee at umich.edu (Ben Yee) Date: Tue, 29 Aug 2017 22:54:18 -0400 Subject: [petsc-users] Red-black block Jacobi in PETSc? In-Reply-To: References: Message-ID: Oh, I could be mistaken, but I don't think the PCApply_PBJacobi_N() function is in the master branch of petsc. (At least, it's not in the pbjacobi.c file that I downloaded for petsc-3.7.6) I did a quick search and found it in this old mat-taij branch: https://bitbucket.org/ petsc/petsc/branch/debo/mat-taij . Is this the function you were referring to? Regarding the block density, I think the matrix is relatively diagonally dominant, but the density is generally a bit higher than 30%. The blocks are of the same size. I think you're right that the factorization is faster, I will try the factorization first. However, I am concerned about the memory cost of the factorizing all of the blocks for problems with a large number of equations, so I think I may have to resort to an iterative solver or doing Gaussian elimination in those cases. On Tue, Aug 29, 2017 at 10:32 PM, Barry Smith wrote: > > > On Aug 29, 2017, at 9:10 PM, Ben Yee wrote: > > > > Thank you for your detailed response! > > > > In my case, the number of equations (the block size) depends on the user > input (there is one equation per energy group, and the number of groups > depends on how the user wants to discretize the energy variable). It > typically is around 50, but can be as high as a few hundred. In > pbjacobi.c, it seems that it is hard-coded to work for a fixed block size > N, but I would like it to work for general N. Moreover, I would like to > solve the blocks iteratively (using SOR for example) since the block sizes > can get rather large. > > > > I haven't tried this yet, but it seems that it wouldn't be too hard to > modify what you have suggested to work as I have described above. I could > add an extra PetscBool to pbjacobi that indicates that I want to use my own > PCApply_PBJacobi which would work for general block size N. And, in that > function, instead of applying a stored inverse block, I could implement SOR > iterations. > > There is a general PCApply_PBJacobi_N() you can start with no need for > a bool. > > Almost for sure if the blocks are more than 30% full you will do better > to to do the factorization and inversion and NOT do SOR. How dense are your > blocks? I am assuming each block is of the same size? > > > Barry > > > > > Does that sound like a good plan, or do you suggest an alternative > approach? > > > > Thanks again for your help on this! > > > > On Tue, Aug 29, 2017 at 9:11 PM, Barry Smith wrote: > > > > Ok, you should be using the BAIJ matrix it supports point-block Jacobi > and point-block Gauss-Seidel. > > > > We do not have a red-black Jacobi/Gauss-Seidel but you could easily > add it. You will add it, not by using a any shell objects but by adding > functionality to the PCPBJACOBI code in PETSc which is in > src/ksp/pc/impls/pbjacobi/pbjacobi.c > > > > First you will need to add a routine to supply the colors (make it > general for any number of colors since the code is basically the same as > for only two colors) call it say > > > > PCPBJacobiSetColors(PC pc,PetscInt number of colors, PetscInt > *sizeofeachcolor, PetscInt **idsforeachcolor); > > > > you will have to add additional fields in PC_PBJacobi to contain this > information. > > > > Then copy the static PetscErrorCode PCApply_PBJacobi_N(PC pc,Vec x,Vec > y) for your block size N (for example 3) and modify it to do what you > want, so for example > > > > static PetscErrorCode PCApply_PBJacobi_2_Color(PC pc,Vec x,Vec y) > > { > > PC_PBJacobi *jac = (PC_PBJacobi*)pc->data; > > PetscErrorCode ierr; > > PetscInt i,m = jac->mbs; > > const MatScalar *diag = jac->diag; > > PetscScalar x0,x1,*yy; > > const PetscScalar *xx; > > > > PetscFunctionBegin; > > if (!jac->b) { > > ierr = VecDuplicate(x,&jac->b); > > ierr = VecDuplicate(x,&jac->work); > > } > > > > ierr = VecCopy(x,b);CHKERRQ(ierr); > > for (j=0; jnumberofcolors; j++) { > > > > ierr = VecGetArrayRead(b,&xx);CHKERRQ(ierr); > > ierr = VecGetArray(y,&yy);CHKERRQ(ierr); > > > > for (i=0; isizeofeachcolor[j]; i++) { > > ii = jac->idsforeachcolor[j][i]; > > diag = jac->diag + 4*ii; > > x0 = xx[2*ii]; x1 = xx[2*ii+1]; > > yy[2*ii] = diag[0]*x0 + diag[2]*x1; > > yy[2*ii+1] = diag[1]*x0 + diag[3]*x1; > > } > > ierr = VecRestoreArrayRead(b,&xx);CHKERRQ(ierr); > > ierr = VecRestoreArray(y,&yy);CHKERRQ(ierr); > > > > /* update residual */ > > if (i < jac->sizeofeachcolor[j]-1) { > > ierr = MatMult(pc->matrix,y,work2); > > ierr = VecAYPX(b,-1,work1); > > } > > } > > > > PetscFunctionReturn(0); > > } > > > > Finally in PCSetUp_PBJacobi() you would set the apply function pointer > to the "color" version if the user has provided the coloring information. > > > > Pretty simple. > > > > Barry > > > > > > > On Aug 29, 2017, at 6:47 PM, Ben Yee wrote: > > > > > > I'm solving a coupled set of equations, so each "block" corresponds to > a set of unknowns for a particular spatial cell. The matrix is structured > such that all of the unknowns for a given spatial cell have adjacent global > matrix indices (i.e., they're next to each other in the global solution > vector). Effectively, I want to do red-black Gauss Seidel, but with > blocks. Alternatively, it's the same as applying block Jacobi for all the > red cells and then applying block Jacobi for all the black cells. > > > > > > The color of the block is determined from the geometry of the problem > which is stored in various structures in the code I'm working on, > independent of petsc. (Physically, I generally have a nice 3d cartesian > spatial grid and the coloring is just a checkerboard in that case.) > > > > > > The reason I want to do this is for research purposes. I've > implemented my own interpolation matrices for PCMG, and, in my simpler 1d > codes and convergence analyses, I've found that doing a red-black smoothing > significantly improved convergence for my particular problem (though I'm > aware that this generally leads to poor cache efficiency). > > > > > > On Aug 29, 2017 7:33 PM, "Barry Smith" wrote: > > > > > > Ben, > > > > > > Please explain more what you mean by "a red-black block Jacobi > smoother". What is your matrix structure? What are the blocks? How do you > decide which ones are which color? Why do you wish to use some a smoother. > > > > > > Barry > > > > > > > On Aug 29, 2017, at 6:19 PM, Ben Yee wrote: > > > > > > > > Hi, > > > > > > > > For the smoother in PCMG, I want to use a red-black block Jacobi > smoother. Is this available with the existing PETSc options? If so, how > do I designate which blocks are red and which are black? > > > > > > > > If it is not possible, what would be the best way to implement > this? Would I use KSPRICHARDSON+PCSHELL? > > > > > > > > Thanks! > > > > > > > > -- > > > > Ben Yee > > > > > > > > NERS PhD Candidate, University of Michigan > > > > B.S. Mech. & Nuclear Eng., U.C. Berkeley > > > > > > > > > > > > > > > > -- > > Ben Yee > > > > NERS PhD Candidate, University of Michigan > > B.S. Mech. & Nuclear Eng., U.C. Berkeley > > -- Ben Yee NERS PhD Candidate, University of Michigan B.S. Mech. & Nuclear Eng., U.C. Berkeley -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Tue Aug 29 22:26:30 2017 From: bsmith at mcs.anl.gov (Barry Smith) Date: Tue, 29 Aug 2017 22:26:30 -0500 Subject: [petsc-users] A number of questions about DMDA with SNES and Quasi-Newton methods In-Reply-To: References: <020DAED9-AAAD-4741-976B-BB2EF6C79D3F@mcs.anl.gov> <5BF530F6-8D79-47E6-B2C5-B0702FF2AA59@mcs.anl.gov> <7EE84495-4346-4BFB-B9AD-BCAA3C722461@mcs.anl.gov> <08AA1273-062D-4FDD-8709-40AA1FE8AA92@mcs.anl.gov> <06932E72-E8F3-4EA8-889F-A570AD660E32@mcs.anl.gov> Message-ID: <98D45588-381F-44FB-9D20-65D1638E357F@mcs.anl.gov> > On Aug 29, 2017, at 9:49 PM, zakaryah . wrote: > > I figured out the cause of my problems with the debugger and the Jacobian evaluation - I had a silly memory corruption issue which is now fixed. > > I am still having trouble with convergence. I am using a test problem of intermediate size, which has nearly identical Jacobians when comparing finite difference to hand-coded. If I run with -snes_type newtonls -snes_monitor -ksp_monitor -ksp_ksp_monitor -ksp_monitor_true_residual -ksp_converged_reason -snes_converged_reason, the very first SNES iteration fails to converge, due to the KSP failing to converge after 10,000 iterations. > > Following the "Why is my iterative solver not converging?" FAQ, I ran the problem on an even smaller grid, with -snes_type newtonls -snes_monitor -ksp_monitor -ksp_ksp_monitor -ksp_monitor_true_residual -ksp_converged_reason -snes_converged_reason -pc_type svd -pc_svd_monitor, and the linear system was not close to singular. I don't have any reason to suspect that the linear system becomes more singular as the grid size increases. Next, I ran with -snes_type newtonls -snes_monitor -ksp_monitor -ksp_ksp_monitor -ksp_monitor_true_residual -ksp_converged_reason -snes_converged_reason -ksp_gmres_restart 1000 -pc_type none, and the KSP seemed to converge better, but the SNES only ran for a few iterations before it stopped with "Nonlinear solve did not converge due to DIVERGED_LINE_SEARCH iterations 7". > > ?Can I conclude from this that running the KSP without a pre-conditioner ?is a good idea? -pc_type none is almost always a bad idea. > At that point, should I go back to asking why the SNES doesn't converge, ala the "Why is Newton's method not converging?" FAQ? Use -pc_type lu and send all the output with -snes_monitor -snes_linesearch_monitor -ksp_monitor Step one is to get Newton converging well, step 2 is to optimize the linear solver, but never do step 2 before step 1, hence stick to LU until Newton is converging well. > > Thanks for the continuing help! > From bsmith at mcs.anl.gov Tue Aug 29 22:28:15 2017 From: bsmith at mcs.anl.gov (Barry Smith) Date: Tue, 29 Aug 2017 22:28:15 -0500 Subject: [petsc-users] Red-black block Jacobi in PETSc? In-Reply-To: References: Message-ID: <7BC2C2BD-5819-48E9-958C-B87B182C4BE8@mcs.anl.gov> Dang, you are right. It could be there, some of the code to write it could be stolen from the PCSOR that does handle a generic size N block. Barry > On Aug 29, 2017, at 9:54 PM, Ben Yee wrote: > > Oh, I could be mistaken, but I don't think the PCApply_PBJacobi_N() function is in the master branch of petsc. (At least, it's not in the pbjacobi.c file that I downloaded for petsc-3.7.6) I did a quick search and found it in this old mat-taij branch: https://bitbucket.org/petsc/petsc/branch/debo/mat-taij . Is this the function you were referring to? > > Regarding the block density, I think the matrix is relatively diagonally dominant, but the density is generally a bit higher than 30%. The blocks are of the same size. I think you're right that the factorization is faster, I will try the factorization first. However, I am concerned about the memory cost of the factorizing all of the blocks for problems with a large number of equations, so I think I may have to resort to an iterative solver or doing Gaussian elimination in those cases. > > On Tue, Aug 29, 2017 at 10:32 PM, Barry Smith wrote: > > > On Aug 29, 2017, at 9:10 PM, Ben Yee wrote: > > > > Thank you for your detailed response! > > > > In my case, the number of equations (the block size) depends on the user input (there is one equation per energy group, and the number of groups depends on how the user wants to discretize the energy variable). It typically is around 50, but can be as high as a few hundred. In pbjacobi.c, it seems that it is hard-coded to work for a fixed block size N, but I would like it to work for general N. Moreover, I would like to solve the blocks iteratively (using SOR for example) since the block sizes can get rather large. > > > > I haven't tried this yet, but it seems that it wouldn't be too hard to modify what you have suggested to work as I have described above. I could add an extra PetscBool to pbjacobi that indicates that I want to use my own PCApply_PBJacobi which would work for general block size N. And, in that function, instead of applying a stored inverse block, I could implement SOR iterations. > > There is a general PCApply_PBJacobi_N() you can start with no need for a bool. > > Almost for sure if the blocks are more than 30% full you will do better to to do the factorization and inversion and NOT do SOR. How dense are your blocks? I am assuming each block is of the same size? > > > Barry > > > > > Does that sound like a good plan, or do you suggest an alternative approach? > > > > Thanks again for your help on this! > > > > On Tue, Aug 29, 2017 at 9:11 PM, Barry Smith wrote: > > > > Ok, you should be using the BAIJ matrix it supports point-block Jacobi and point-block Gauss-Seidel. > > > > We do not have a red-black Jacobi/Gauss-Seidel but you could easily add it. You will add it, not by using a any shell objects but by adding functionality to the PCPBJACOBI code in PETSc which is in src/ksp/pc/impls/pbjacobi/pbjacobi.c > > > > First you will need to add a routine to supply the colors (make it general for any number of colors since the code is basically the same as for only two colors) call it say > > > > PCPBJacobiSetColors(PC pc,PetscInt number of colors, PetscInt *sizeofeachcolor, PetscInt **idsforeachcolor); > > > > you will have to add additional fields in PC_PBJacobi to contain this information. > > > > Then copy the static PetscErrorCode PCApply_PBJacobi_N(PC pc,Vec x,Vec y) for your block size N (for example 3) and modify it to do what you want, so for example > > > > static PetscErrorCode PCApply_PBJacobi_2_Color(PC pc,Vec x,Vec y) > > { > > PC_PBJacobi *jac = (PC_PBJacobi*)pc->data; > > PetscErrorCode ierr; > > PetscInt i,m = jac->mbs; > > const MatScalar *diag = jac->diag; > > PetscScalar x0,x1,*yy; > > const PetscScalar *xx; > > > > PetscFunctionBegin; > > if (!jac->b) { > > ierr = VecDuplicate(x,&jac->b); > > ierr = VecDuplicate(x,&jac->work); > > } > > > > ierr = VecCopy(x,b);CHKERRQ(ierr); > > for (j=0; jnumberofcolors; j++) { > > > > ierr = VecGetArrayRead(b,&xx);CHKERRQ(ierr); > > ierr = VecGetArray(y,&yy);CHKERRQ(ierr); > > > > for (i=0; isizeofeachcolor[j]; i++) { > > ii = jac->idsforeachcolor[j][i]; > > diag = jac->diag + 4*ii; > > x0 = xx[2*ii]; x1 = xx[2*ii+1]; > > yy[2*ii] = diag[0]*x0 + diag[2]*x1; > > yy[2*ii+1] = diag[1]*x0 + diag[3]*x1; > > } > > ierr = VecRestoreArrayRead(b,&xx);CHKERRQ(ierr); > > ierr = VecRestoreArray(y,&yy);CHKERRQ(ierr); > > > > /* update residual */ > > if (i < jac->sizeofeachcolor[j]-1) { > > ierr = MatMult(pc->matrix,y,work2); > > ierr = VecAYPX(b,-1,work1); > > } > > } > > > > PetscFunctionReturn(0); > > } > > > > Finally in PCSetUp_PBJacobi() you would set the apply function pointer to the "color" version if the user has provided the coloring information. > > > > Pretty simple. > > > > Barry > > > > > > > On Aug 29, 2017, at 6:47 PM, Ben Yee wrote: > > > > > > I'm solving a coupled set of equations, so each "block" corresponds to a set of unknowns for a particular spatial cell. The matrix is structured such that all of the unknowns for a given spatial cell have adjacent global matrix indices (i.e., they're next to each other in the global solution vector). Effectively, I want to do red-black Gauss Seidel, but with blocks. Alternatively, it's the same as applying block Jacobi for all the red cells and then applying block Jacobi for all the black cells. > > > > > > The color of the block is determined from the geometry of the problem which is stored in various structures in the code I'm working on, independent of petsc. (Physically, I generally have a nice 3d cartesian spatial grid and the coloring is just a checkerboard in that case.) > > > > > > The reason I want to do this is for research purposes. I've implemented my own interpolation matrices for PCMG, and, in my simpler 1d codes and convergence analyses, I've found that doing a red-black smoothing significantly improved convergence for my particular problem (though I'm aware that this generally leads to poor cache efficiency). > > > > > > On Aug 29, 2017 7:33 PM, "Barry Smith" wrote: > > > > > > Ben, > > > > > > Please explain more what you mean by "a red-black block Jacobi smoother". What is your matrix structure? What are the blocks? How do you decide which ones are which color? Why do you wish to use some a smoother. > > > > > > Barry > > > > > > > On Aug 29, 2017, at 6:19 PM, Ben Yee wrote: > > > > > > > > Hi, > > > > > > > > For the smoother in PCMG, I want to use a red-black block Jacobi smoother. Is this available with the existing PETSc options? If so, how do I designate which blocks are red and which are black? > > > > > > > > If it is not possible, what would be the best way to implement this? Would I use KSPRICHARDSON+PCSHELL? > > > > > > > > Thanks! > > > > > > > > -- > > > > Ben Yee > > > > > > > > NERS PhD Candidate, University of Michigan > > > > B.S. Mech. & Nuclear Eng., U.C. Berkeley > > > > > > > > > > > > > > > > -- > > Ben Yee > > > > NERS PhD Candidate, University of Michigan > > B.S. Mech. & Nuclear Eng., U.C. Berkeley > > > > > -- > Ben Yee > > NERS PhD Candidate, University of Michigan > B.S. Mech. & Nuclear Eng., U.C. Berkeley From jed at jedbrown.org Tue Aug 29 22:31:49 2017 From: jed at jedbrown.org (Jed Brown) Date: Tue, 29 Aug 2017 21:31:49 -0600 Subject: [petsc-users] Red-black block Jacobi in PETSc? In-Reply-To: References: Message-ID: <871snthgt6.fsf@jedbrown.org> Barry Smith writes: > Ok, you should be using the BAIJ matrix it supports point-block Jacobi and point-block Gauss-Seidel. > > We do not have a red-black Jacobi/Gauss-Seidel but you could easily add it. You will add it, not by using a any shell objects but by adding functionality to the PCPBJACOBI code in PETSc which is in src/ksp/pc/impls/pbjacobi/pbjacobi.c > > First you will need to add a routine to supply the colors (make it general for any number of colors since the code is basically the same as for only two colors) call it say > > PCPBJacobiSetColors(PC pc,PetscInt number of colors, PetscInt *sizeofeachcolor, PetscInt **idsforeachcolor); > > you will have to add additional fields in PC_PBJacobi to contain this information. > > Then copy the static PetscErrorCode PCApply_PBJacobi_N(PC pc,Vec x,Vec y) for your block size N (for example 3) and modify it to do what you want, so for example > > static PetscErrorCode PCApply_PBJacobi_2_Color(PC pc,Vec x,Vec y) > { > PC_PBJacobi *jac = (PC_PBJacobi*)pc->data; > PetscErrorCode ierr; > PetscInt i,m = jac->mbs; > const MatScalar *diag = jac->diag; > PetscScalar x0,x1,*yy; > const PetscScalar *xx; > > PetscFunctionBegin; > if (!jac->b) { > ierr = VecDuplicate(x,&jac->b); > ierr = VecDuplicate(x,&jac->work); > } > > ierr = VecCopy(x,b);CHKERRQ(ierr); > for (j=0; jnumberofcolors; j++) { > > ierr = VecGetArrayRead(b,&xx);CHKERRQ(ierr); > ierr = VecGetArray(y,&yy);CHKERRQ(ierr); > > for (i=0; isizeofeachcolor[j]; i++) { > ii = jac->idsforeachcolor[j][i]; > diag = jac->diag + 4*ii; > x0 = xx[2*ii]; x1 = xx[2*ii+1]; > yy[2*ii] = diag[0]*x0 + diag[2]*x1; > yy[2*ii+1] = diag[1]*x0 + diag[3]*x1; > } > ierr = VecRestoreArrayRead(b,&xx);CHKERRQ(ierr); > ierr = VecRestoreArray(y,&yy);CHKERRQ(ierr); > > /* update residual */ > if (i < jac->sizeofeachcolor[j]-1) { > ierr = MatMult(pc->matrix,y,work2); > ierr = VecAYPX(b,-1,work1); > } > } Why this way instead of adding the functionality to SOR? This global residual update is horribly inefficient compared to merely computing the residual on each color. > PetscFunctionReturn(0); > } > > Finally in PCSetUp_PBJacobi() you would set the apply function pointer to the "color" version if the user has provided the coloring information. > > Pretty simple. > > Barry > > >> On Aug 29, 2017, at 6:47 PM, Ben Yee wrote: >> >> I'm solving a coupled set of equations, so each "block" corresponds to a set of unknowns for a particular spatial cell. The matrix is structured such that all of the unknowns for a given spatial cell have adjacent global matrix indices (i.e., they're next to each other in the global solution vector). Effectively, I want to do red-black Gauss Seidel, but with blocks. Alternatively, it's the same as applying block Jacobi for all the red cells and then applying block Jacobi for all the black cells. >> >> The color of the block is determined from the geometry of the problem which is stored in various structures in the code I'm working on, independent of petsc. (Physically, I generally have a nice 3d cartesian spatial grid and the coloring is just a checkerboard in that case.) >> >> The reason I want to do this is for research purposes. I've implemented my own interpolation matrices for PCMG, and, in my simpler 1d codes and convergence analyses, I've found that doing a red-black smoothing significantly improved convergence for my particular problem (though I'm aware that this generally leads to poor cache efficiency). >> >> On Aug 29, 2017 7:33 PM, "Barry Smith" wrote: >> >> Ben, >> >> Please explain more what you mean by "a red-black block Jacobi smoother". What is your matrix structure? What are the blocks? How do you decide which ones are which color? Why do you wish to use some a smoother. >> >> Barry >> >> > On Aug 29, 2017, at 6:19 PM, Ben Yee wrote: >> > >> > Hi, >> > >> > For the smoother in PCMG, I want to use a red-black block Jacobi smoother. Is this available with the existing PETSc options? If so, how do I designate which blocks are red and which are black? >> > >> > If it is not possible, what would be the best way to implement this? Would I use KSPRICHARDSON+PCSHELL? >> > >> > Thanks! >> > >> > -- >> > Ben Yee >> > >> > NERS PhD Candidate, University of Michigan >> > B.S. Mech. & Nuclear Eng., U.C. Berkeley >> >> -------------- next part -------------- A non-text attachment was scrubbed... Name: signature.asc Type: application/pgp-signature Size: 832 bytes Desc: not available URL: From bsmith at mcs.anl.gov Tue Aug 29 22:35:36 2017 From: bsmith at mcs.anl.gov (Barry Smith) Date: Tue, 29 Aug 2017 22:35:36 -0500 Subject: [petsc-users] Red-black block Jacobi in PETSc? In-Reply-To: <871snthgt6.fsf@jedbrown.org> References: <871snthgt6.fsf@jedbrown.org> Message-ID: > On Aug 29, 2017, at 10:31 PM, Jed Brown wrote: > > Barry Smith writes: > >> Ok, you should be using the BAIJ matrix it supports point-block Jacobi and point-block Gauss-Seidel. >> >> We do not have a red-black Jacobi/Gauss-Seidel but you could easily add it. You will add it, not by using a any shell objects but by adding functionality to the PCPBJACOBI code in PETSc which is in src/ksp/pc/impls/pbjacobi/pbjacobi.c >> >> First you will need to add a routine to supply the colors (make it general for any number of colors since the code is basically the same as for only two colors) call it say >> >> PCPBJacobiSetColors(PC pc,PetscInt number of colors, PetscInt *sizeofeachcolor, PetscInt **idsforeachcolor); >> >> you will have to add additional fields in PC_PBJacobi to contain this information. >> >> Then copy the static PetscErrorCode PCApply_PBJacobi_N(PC pc,Vec x,Vec y) for your block size N (for example 3) and modify it to do what you want, so for example >> >> static PetscErrorCode PCApply_PBJacobi_2_Color(PC pc,Vec x,Vec y) >> { >> PC_PBJacobi *jac = (PC_PBJacobi*)pc->data; >> PetscErrorCode ierr; >> PetscInt i,m = jac->mbs; >> const MatScalar *diag = jac->diag; >> PetscScalar x0,x1,*yy; >> const PetscScalar *xx; >> >> PetscFunctionBegin; >> if (!jac->b) { >> ierr = VecDuplicate(x,&jac->b); >> ierr = VecDuplicate(x,&jac->work); >> } >> >> ierr = VecCopy(x,b);CHKERRQ(ierr); >> for (j=0; jnumberofcolors; j++) { >> >> ierr = VecGetArrayRead(b,&xx);CHKERRQ(ierr); >> ierr = VecGetArray(y,&yy);CHKERRQ(ierr); >> >> for (i=0; isizeofeachcolor[j]; i++) { >> ii = jac->idsforeachcolor[j][i]; >> diag = jac->diag + 4*ii; >> x0 = xx[2*ii]; x1 = xx[2*ii+1]; >> yy[2*ii] = diag[0]*x0 + diag[2]*x1; >> yy[2*ii+1] = diag[1]*x0 + diag[3]*x1; >> } >> ierr = VecRestoreArrayRead(b,&xx);CHKERRQ(ierr); >> ierr = VecRestoreArray(y,&yy);CHKERRQ(ierr); >> >> /* update residual */ >> if (i < jac->sizeofeachcolor[j]-1) { >> ierr = MatMult(pc->matrix,y,work2); >> ierr = VecAYPX(b,-1,work1); >> } >> } > > Why this way instead of adding the functionality to SOR? This global > residual update is horribly inefficient compared to merely computing the > residual on each color. True, but if this is for theoretical studies of convergence and not optimal performance it is easier. For example you do this and see the convergence is much better with coloring than without and then conclude it is worth spending the time to do it properly within an SOR framework. Barry > >> PetscFunctionReturn(0); >> } >> >> Finally in PCSetUp_PBJacobi() you would set the apply function pointer to the "color" version if the user has provided the coloring information. >> >> Pretty simple. >> >> Barry >> >> >>> On Aug 29, 2017, at 6:47 PM, Ben Yee wrote: >>> >>> I'm solving a coupled set of equations, so each "block" corresponds to a set of unknowns for a particular spatial cell. The matrix is structured such that all of the unknowns for a given spatial cell have adjacent global matrix indices (i.e., they're next to each other in the global solution vector). Effectively, I want to do red-black Gauss Seidel, but with blocks. Alternatively, it's the same as applying block Jacobi for all the red cells and then applying block Jacobi for all the black cells. >>> >>> The color of the block is determined from the geometry of the problem which is stored in various structures in the code I'm working on, independent of petsc. (Physically, I generally have a nice 3d cartesian spatial grid and the coloring is just a checkerboard in that case.) >>> >>> The reason I want to do this is for research purposes. I've implemented my own interpolation matrices for PCMG, and, in my simpler 1d codes and convergence analyses, I've found that doing a red-black smoothing significantly improved convergence for my particular problem (though I'm aware that this generally leads to poor cache efficiency). >>> >>> On Aug 29, 2017 7:33 PM, "Barry Smith" wrote: >>> >>> Ben, >>> >>> Please explain more what you mean by "a red-black block Jacobi smoother". What is your matrix structure? What are the blocks? How do you decide which ones are which color? Why do you wish to use some a smoother. >>> >>> Barry >>> >>>> On Aug 29, 2017, at 6:19 PM, Ben Yee wrote: >>>> >>>> Hi, >>>> >>>> For the smoother in PCMG, I want to use a red-black block Jacobi smoother. Is this available with the existing PETSc options? If so, how do I designate which blocks are red and which are black? >>>> >>>> If it is not possible, what would be the best way to implement this? Would I use KSPRICHARDSON+PCSHELL? >>>> >>>> Thanks! >>>> >>>> -- >>>> Ben Yee >>>> >>>> NERS PhD Candidate, University of Michigan >>>> B.S. Mech. & Nuclear Eng., U.C. Berkeley >>> >>> From zakaryah at gmail.com Tue Aug 29 23:21:21 2017 From: zakaryah at gmail.com (zakaryah .) Date: Wed, 30 Aug 2017 00:21:21 -0400 Subject: [petsc-users] A number of questions about DMDA with SNES and Quasi-Newton methods In-Reply-To: <98D45588-381F-44FB-9D20-65D1638E357F@mcs.anl.gov> References: <020DAED9-AAAD-4741-976B-BB2EF6C79D3F@mcs.anl.gov> <5BF530F6-8D79-47E6-B2C5-B0702FF2AA59@mcs.anl.gov> <7EE84495-4346-4BFB-B9AD-BCAA3C722461@mcs.anl.gov> <08AA1273-062D-4FDD-8709-40AA1FE8AA92@mcs.anl.gov> <06932E72-E8F3-4EA8-889F-A570AD660E32@mcs.anl.gov> <98D45588-381F-44FB-9D20-65D1638E357F@mcs.anl.gov> Message-ID: ?OK, this is very helpful (and not totally clear from the "Why is Newton's method not converging" FAQ at this address: https://scicomp.stackexchange.com/questions/30/why-is-newtons-method-not-converging. Here's the output, using the intermediate grid and the options -snes_type newtonls -snes_monitor -ksp_monitor -ksp_monitor_true_residual -ksp_converged_reason -snes_converged_reason -pc_type lu -snes_linesearch_monitor:? 0 SNES Function norm 1.370293318432e+04 0 KSP Residual norm 7.457516441709e+02 0 KSP preconditioned resid norm 7.457516441709e+02 true resid norm 1.370293318432e+04 ||r(i)||/||b|| 1.000000000000e+00 1 KSP Residual norm 1.244742959480e-10 1 KSP preconditioned resid norm 1.244742959480e-10 true resid norm 9.866304569403e-09 ||r(i)||/||b|| 7.200140609815e-13 Linear solve converged due to CONVERGED_RTOL iterations 1 Line search: gnorm after quadratic fit 6.541326653047e+05 Line search: Cubic step no good, shrinking lambda, current gnorm 8.963755251044e+04 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.788913078169e+04 lambda=2.5000000000000001e-02 Line search: Cubically determined step, current gnorm 1.340565818376e+04 lambda=1.2500000000000001e-02 1 SNES Function norm 1.340565818376e+04 0 KSP Residual norm 3.837938728414e+02 0 KSP preconditioned resid norm 3.837938728414e+02 true resid norm 1.340565818376e+04 ||r(i)||/||b|| 1.000000000000e+00 1 KSP Residual norm 3.935624425879e-11 1 KSP preconditioned resid norm 3.935624425879e-11 true resid norm 4.012917478400e-09 ||r(i)||/||b|| 2.993450544086e-13 Linear solve converged due to CONVERGED_RTOL iterations 1 Line search: gnorm after quadratic fit 7.752009107979e+05 Line search: Cubic step no good, shrinking lambda, current gnorm 9.942192482364e+04 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.724069009956e+04 lambda=2.5000000000000001e-02 Line search: Cubically determined step, current gnorm 1.272263847462e+04 lambda=1.2500000000000001e-02 2 SNES Function norm 1.272263847462e+04 0 KSP Residual norm 8.610741245938e+01 0 KSP preconditioned resid norm 8.610741245938e+01 true resid norm 1.272263847462e+04 ||r(i)||/||b|| 1.000000000000e+00 1 KSP Residual norm 3.953708398506e-12 1 KSP preconditioned resid norm 3.953708398506e-12 true resid norm 1.259105691297e-09 ||r(i)||/||b|| 9.896576828850e-14 Linear solve converged due to CONVERGED_RTOL iterations 1 Line search: gnorm after quadratic fit 1.126216236986e+04 Line search: Quadratically determined step, lambda=1.0000000000000001e-01 3 SNES Function norm 1.126216236986e+04 0 KSP Residual norm 6.100581225849e+01 0 KSP preconditioned resid norm 6.100581225849e+01 true resid norm 1.126216236986e+04 ||r(i)||/||b|| 1.000000000000e+00 1 KSP Residual norm 3.714526144776e-12 1 KSP preconditioned resid norm 3.714526144776e-12 true resid norm 1.150524854441e-09 ||r(i)||/||b|| 1.021584325156e-13 Linear solve converged due to CONVERGED_RTOL iterations 1 Line search: gnorm after quadratic fit 9.992994468502e+03 Line search: Quadratically determined step, lambda=1.0000000000000001e-01 4 SNES Function norm 9.992994468502e+03 0 KSP Residual norm 5.452156705070e+01 0 KSP preconditioned resid norm 5.452156705070e+01 true resid norm 9.992994468502e+03 ||r(i)||/||b|| 1.000000000000e+00 1 KSP Residual norm 2.345517221383e-12 1 KSP preconditioned resid norm 2.345517221383e-12 true resid norm 6.645776037775e-10 ||r(i)||/||b|| 6.650435020976e-14 Linear solve converged due to CONVERGED_RTOL iterations 1 Line search: gnorm after quadratic fit 8.954956134809e+03 Line search: Quadratically determined step, lambda=1.0000000000000001e-01 5 SNES Function norm 8.954956134809e+03 0 KSP Residual norm 1.869342714623e+02 0 KSP preconditioned resid norm 1.869342714623e+02 true resid norm 8.954956134809e+03 ||r(i)||/||b|| 1.000000000000e+00 1 KSP Residual norm 6.952075013553e-12 1 KSP preconditioned resid norm 6.952075013553e-12 true resid norm 2.332836306210e-09 ||r(i)||/||b|| 2.605078429298e-13 Linear solve converged due to CONVERGED_RTOL iterations 1 Line search: gnorm after quadratic fit 9.366608314830e+04 Line search: Cubic step no good, shrinking lambda, current gnorm 1.702858832608e+04 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 9.141708166107e+03 lambda=2.5000000000000001e-02 Line search: Cubically determined step, current gnorm 8.847002105227e+03 lambda=1.2500000000000001e-02 6 SNES Function norm 8.847002105227e+03 0 KSP Residual norm 4.136774315749e+01 0 KSP preconditioned resid norm 4.136774315749e+01 true resid norm 8.847002105227e+03 ||r(i)||/||b|| 1.000000000000e+00 1 KSP Residual norm 2.340140336645e-12 1 KSP preconditioned resid norm 2.340140336645e-12 true resid norm 6.952836046439e-10 ||r(i)||/||b|| 7.858974106416e-14 Linear solve converged due to CONVERGED_RTOL iterations 1 Line search: gnorm after quadratic fit 7.928904942575e+03 Line search: Quadratically determined step, lambda=1.0000000000000001e-01 7 SNES Function norm 7.928904942575e+03 0 KSP Residual norm 9.421715655897e+01 0 KSP preconditioned resid norm 9.421715655897e+01 true resid norm 7.928904942575e+03 ||r(i)||/||b|| 1.000000000000e+00 1 KSP Residual norm 5.662350656880e-12 1 KSP preconditioned resid norm 5.662350656880e-12 true resid norm 1.323447274435e-09 ||r(i)||/||b|| 1.669142566370e-13 Linear solve converged due to CONVERGED_RTOL iterations 1 Line search: gnorm after quadratic fit 4.679455846837e+04 Line search: Cubic step no good, shrinking lambda, current gnorm 1.024301325332e+04 lambda=5.0000000000000003e-02 Line search: Cubically determined step, current gnorm 7.882357228991e+03 lambda=2.5000000000000001e-02 8 SNES Function norm 7.882357228991e+03 0 KSP Residual norm 3.101373992455e+01 0 KSP preconditioned resid norm 3.101373992455e+01 true resid norm 7.882357228991e+03 ||r(i)||/||b|| 1.000000000000e+00 1 KSP Residual norm 1.176793992597e-12 1 KSP preconditioned resid norm 1.176793992597e-12 true resid norm 4.948698048884e-10 ||r(i)||/||b|| 6.278195602050e-14 Linear solve converged due to CONVERGED_RTOL iterations 1 Line search: Using full step: fnorm 7.882357228991e+03 gnorm 5.263287196819e+03 9 SNES Function norm 5.263287196819e+03 0 KSP Residual norm 8.541947236232e+00 0 KSP preconditioned resid norm 8.541947236232e+00 true resid norm 5.263287196819e+03 ||r(i)||/||b|| 1.000000000000e+00 1 KSP Residual norm 1.741221887649e-12 1 KSP preconditioned resid norm 1.741221887649e-12 true resid norm 9.735248249306e-10 ||r(i)||/||b|| 1.849651726242e-13 Linear solve converged due to CONVERGED_RTOL iterations 1 Line search: gnorm after quadratic fit 4.836381737060e+03 Line search: Quadratically determined step, lambda=1.0000000000000001e-01 10 SNES Function norm 4.836381737060e+03 0 KSP Residual norm 1.926518638579e+01 0 KSP preconditioned resid norm 1.926518638579e+01 true resid norm 4.836381737060e+03 ||r(i)||/||b|| 1.000000000000e+00 1 KSP Residual norm 1.278653333162e-11 1 KSP preconditioned resid norm 1.278653333162e-11 true resid norm 1.211659620475e-08 ||r(i)||/||b|| 2.505301868938e-12 Linear solve converged due to CONVERGED_RTOL iterations 1 Line search: gnorm after quadratic fit 4.550187794983e+03 Line search: Quadratically determined step, lambda=1.0000000000000001e-01 11 SNES Function norm 4.550187794983e+03 0 KSP Residual norm 5.492305435155e+00 0 KSP preconditioned resid norm 5.492305435155e+00 true resid norm 4.550187794983e+03 ||r(i)||/||b|| 1.000000000000e+00 1 KSP Residual norm 3.941029797735e-13 1 KSP preconditioned resid norm 3.941029797735e-13 true resid norm 2.123615113926e-10 ||r(i)||/||b|| 4.667093336823e-14 Linear solve converged due to CONVERGED_RTOL iterations 1 Line search: gnorm after quadratic fit 3.210238905481e+03 Line search: Quadratically determined step, lambda=4.4544417493894700e-01 12 SNES Function norm 3.210238905481e+03 0 KSP Residual norm 7.578202966222e+00 0 KSP preconditioned resid norm 7.578202966222e+00 true resid norm 3.210238905481e+03 ||r(i)||/||b|| 1.000000000000e+00 1 KSP Residual norm 3.800509410151e-12 1 KSP preconditioned resid norm 3.800509410151e-12 true resid norm 3.408323024026e-09 ||r(i)||/||b|| 1.061703855812e-12 Linear solve converged due to CONVERGED_RTOL iterations 1 Line search: gnorm after quadratic fit 2.924559961092e+03 Line search: Quadratically determined step, lambda=1.0000000000000001e-01 13 SNES Function norm 2.924559961092e+03 0 KSP Residual norm 5.076980628354e+00 0 KSP preconditioned resid norm 5.076980628354e+00 true resid norm 2.924559961092e+03 ||r(i)||/||b|| 1.000000000000e+00 1 KSP Residual norm 1.468522311180e-13 1 KSP preconditioned resid norm 1.468522311180e-13 true resid norm 9.059064389128e-11 ||r(i)||/||b|| 3.097582032733e-14 Linear solve converged due to CONVERGED_RTOL iterations 1 Line search: gnorm after quadratic fit 2.389633730237e+03 Line search: Quadratically determined step, lambda=2.1257217805235396e-01 14 SNES Function norm 2.389633730237e+03 0 KSP Residual norm 5.166598232781e+00 0 KSP preconditioned resid norm 5.166598232781e+00 true resid norm 2.389633730237e+03 ||r(i)||/||b|| 1.000000000000e+00 1 KSP Residual norm 2.249406847764e-13 1 KSP preconditioned resid norm 2.249406847764e-13 true resid norm 4.780078098549e-11 ||r(i)||/||b|| 2.000339231098e-14 Linear solve converged due to CONVERGED_RTOL iterations 1 Line search: gnorm after quadratic fit 2.093485770827e+03 Line search: Quadratically determined step, lambda=1.5993239844479040e-01 15 SNES Function norm 2.093485770827e+03 0 KSP Residual norm 8.445727235216e+00 0 KSP preconditioned resid norm 8.445727235216e+00 true resid norm 2.093485770827e+03 ||r(i)||/||b|| 1.000000000000e+00 1 KSP Residual norm 1.917214128329e-13 1 KSP preconditioned resid norm 1.917214128329e-13 true resid norm 1.577089911021e-10 ||r(i)||/||b|| 7.533320421842e-14 Linear solve converged due to CONVERGED_RTOL iterations 1 Line search: gnorm after quadratic fit 1.967949189728e+03 Line search: Quadratically determined step, lambda=1.0000000000000001e-01 16 SNES Function norm 1.967949189728e+03 0 KSP Residual norm 2.548962277036e+01 0 KSP preconditioned resid norm 2.548962277036e+01 true resid norm 1.967949189728e+03 ||r(i)||/||b|| 1.000000000000e+00 1 KSP Residual norm 4.393171339150e-12 1 KSP preconditioned resid norm 4.393171339150e-12 true resid norm 6.268541493766e-10 ||r(i)||/||b|| 3.185316738097e-13 Linear solve converged due to CONVERGED_RTOL iterations 1 Line search: gnorm after quadratic fit 3.445905389608e+03 Line search: Cubic step no good, shrinking lambda, current gnorm 2.129006719528e+03 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.969320033677e+03 lambda=1.8287150237426619e-02 Line search: Cubically determined step, current gnorm 1.963119931876e+03 lambda=8.7403113229804347e-03 17 SNES Function norm 1.963119931876e+03 0 KSP Residual norm 1.189834379636e+02 0 KSP preconditioned resid norm 1.189834379636e+02 true resid norm 1.963119931876e+03 ||r(i)||/||b|| 1.000000000000e+00 1 KSP Residual norm 3.213937715681e-11 1 KSP preconditioned resid norm 3.213937715681e-11 true resid norm 8.137767291258e-08 ||r(i)||/||b|| 4.145323553147e-11 Linear solve converged due to CONVERGED_RTOL iterations 1 Line search: gnorm after quadratic fit 1.329932469429e+05 Line search: Cubic step no good, shrinking lambda, current gnorm 2.079971894561e+04 lambda=5.0000000000000003e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 4.672632539568e+03 lambda=2.5000000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 2.337320012333e+03 lambda=1.2500000000000001e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.989655494060e+03 lambda=3.7908486903933652e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 1.964061592872e+03 lambda=4.3979444116724767e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 1.963285343925e+03 lambda=9.8760011176842895e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 1.963156689078e+03 lambda=2.3385231527184855e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 1.963128672876e+03 lambda=5.6482781216089357e-06 Line search: Cubic step no good, shrinking lambda, current gnorm 1.963122042807e+03 lambda=1.3692247365910180e-06 Line search: Cubic step no good, shrinking lambda, current gnorm 1.963120443658e+03 lambda=3.3226543340386796e-07 Line search: Cubic step no good, shrinking lambda, current gnorm 1.963120056069e+03 lambda=8.0648305027594934e-08 Line search: Cubic step no good, shrinking lambda, current gnorm 1.963119962021e+03 lambda=1.9576315045380916e-08 Line search: Cubic step no good, shrinking lambda, current gnorm 1.963119939193e+03 lambda=4.7519586695347587e-09 Line search: Cubic step no good, shrinking lambda, current gnorm 1.963119933652e+03 lambda=1.1534950726729967e-09 Line search: Cubic step no good, shrinking lambda, current gnorm 1.963119932307e+03 lambda=2.8000026447574534e-10 Line search: Cubic step no good, shrinking lambda, current gnorm 1.963119931981e+03 lambda=6.7967445495582766e-11 Line search: Cubic step no good, shrinking lambda, current gnorm 1.963119931902e+03 lambda=1.6498100190994443e-11 Line search: Cubic step no good, shrinking lambda, current gnorm 1.963119931882e+03 lambda=4.0046243381676681e-12 Line search: Cubic step no good, shrinking lambda, current gnorm 1.963119931878e+03 lambda=9.7209812173761137e-13 Line search: unable to find good step length! After 19 tries Line search: fnorm=1.9631199318761367e+03, gnorm=1.9631199318776339e+03, ynorm=1.1898343796305618e+02, minlambda=9.9999999999999998e-13, lambda=9.7209812173761137e-13, initial slope=-3.8538398668951751e+06 Nonlinear solve did not converge due to DIVERGED_LINE_SEARCH iterations 17 -------------- next part -------------- An HTML attachment was scrubbed... URL: From knepley at gmail.com Wed Aug 30 11:37:50 2017 From: knepley at gmail.com (Matthew Knepley) Date: Wed, 30 Aug 2017 12:37:50 -0400 Subject: [petsc-users] A number of questions about DMDA with SNES and Quasi-Newton methods In-Reply-To: References: <020DAED9-AAAD-4741-976B-BB2EF6C79D3F@mcs.anl.gov> <5BF530F6-8D79-47E6-B2C5-B0702FF2AA59@mcs.anl.gov> <7EE84495-4346-4BFB-B9AD-BCAA3C722461@mcs.anl.gov> <08AA1273-062D-4FDD-8709-40AA1FE8AA92@mcs.anl.gov> <06932E72-E8F3-4EA8-889F-A570AD660E32@mcs.anl.gov> <98D45588-381F-44FB-9D20-65D1638E357F@mcs.anl.gov> Message-ID: On Wed, Aug 30, 2017 at 12:21 AM, zakaryah . wrote: > ?OK, this is very helpful (and not totally clear from the "Why is Newton's > method not converging" FAQ at this address: https://scicomp.stackexchange. > com/questions/30/why-is-newtons-method-not-converging. Here's the > output, using the intermediate grid and the options -snes_type newtonls > -snes_monitor -ksp_monitor -ksp_monitor_true_residual -ksp_converged_reason > -snes_converged_reason -pc_type lu -snes_linesearch_monitor:? > > 0 SNES Function norm 1.370293318432e+04 > > 0 KSP Residual norm 7.457516441709e+02 > > 0 KSP preconditioned resid norm 7.457516441709e+02 true resid norm > 1.370293318432e+04 ||r(i)||/||b|| 1.000000000000e+00 > > 1 KSP Residual norm 1.244742959480e-10 > > 1 KSP preconditioned resid norm 1.244742959480e-10 true resid norm > 9.866304569403e-09 ||r(i)||/||b|| 7.200140609815e-13 > > Linear solve converged due to CONVERGED_RTOL iterations 1 > > Line search: gnorm after quadratic fit 6.541326653047e+05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 8.963755251044e+04 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.788913078169e+04 lambda=2.5000000000000001e-02 > > Line search: Cubically determined step, current gnorm > 1.340565818376e+04 lambda=1.2500000000000001e-02 > Your Jacobian is wrong. You solved the Newton linear system, which should be guaranteed to give a residual reduction, but you get nothing. Thus we conclude that your Jacobian is wrong, giving a wrong descent direction. I would recommend simplifying the problem until you can check the Jacobian entries by hand. Thanks, Matt > 1 SNES Function norm 1.340565818376e+04 > > 0 KSP Residual norm 3.837938728414e+02 > > 0 KSP preconditioned resid norm 3.837938728414e+02 true resid norm > 1.340565818376e+04 ||r(i)||/||b|| 1.000000000000e+00 > > 1 KSP Residual norm 3.935624425879e-11 > > 1 KSP preconditioned resid norm 3.935624425879e-11 true resid norm > 4.012917478400e-09 ||r(i)||/||b|| 2.993450544086e-13 > > Linear solve converged due to CONVERGED_RTOL iterations 1 > > Line search: gnorm after quadratic fit 7.752009107979e+05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 9.942192482364e+04 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.724069009956e+04 lambda=2.5000000000000001e-02 > > Line search: Cubically determined step, current gnorm > 1.272263847462e+04 lambda=1.2500000000000001e-02 > > 2 SNES Function norm 1.272263847462e+04 > > 0 KSP Residual norm 8.610741245938e+01 > > 0 KSP preconditioned resid norm 8.610741245938e+01 true resid norm > 1.272263847462e+04 ||r(i)||/||b|| 1.000000000000e+00 > > 1 KSP Residual norm 3.953708398506e-12 > > 1 KSP preconditioned resid norm 3.953708398506e-12 true resid norm > 1.259105691297e-09 ||r(i)||/||b|| 9.896576828850e-14 > > Linear solve converged due to CONVERGED_RTOL iterations 1 > > Line search: gnorm after quadratic fit 1.126216236986e+04 > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > 3 SNES Function norm 1.126216236986e+04 > > 0 KSP Residual norm 6.100581225849e+01 > > 0 KSP preconditioned resid norm 6.100581225849e+01 true resid norm > 1.126216236986e+04 ||r(i)||/||b|| 1.000000000000e+00 > > 1 KSP Residual norm 3.714526144776e-12 > > 1 KSP preconditioned resid norm 3.714526144776e-12 true resid norm > 1.150524854441e-09 ||r(i)||/||b|| 1.021584325156e-13 > > Linear solve converged due to CONVERGED_RTOL iterations 1 > > Line search: gnorm after quadratic fit 9.992994468502e+03 > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > 4 SNES Function norm 9.992994468502e+03 > > 0 KSP Residual norm 5.452156705070e+01 > > 0 KSP preconditioned resid norm 5.452156705070e+01 true resid norm > 9.992994468502e+03 ||r(i)||/||b|| 1.000000000000e+00 > > 1 KSP Residual norm 2.345517221383e-12 > > 1 KSP preconditioned resid norm 2.345517221383e-12 true resid norm > 6.645776037775e-10 ||r(i)||/||b|| 6.650435020976e-14 > > Linear solve converged due to CONVERGED_RTOL iterations 1 > > Line search: gnorm after quadratic fit 8.954956134809e+03 > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > 5 SNES Function norm 8.954956134809e+03 > > 0 KSP Residual norm 1.869342714623e+02 > > 0 KSP preconditioned resid norm 1.869342714623e+02 true resid norm > 8.954956134809e+03 ||r(i)||/||b|| 1.000000000000e+00 > > 1 KSP Residual norm 6.952075013553e-12 > > 1 KSP preconditioned resid norm 6.952075013553e-12 true resid norm > 2.332836306210e-09 ||r(i)||/||b|| 2.605078429298e-13 > > Linear solve converged due to CONVERGED_RTOL iterations 1 > > Line search: gnorm after quadratic fit 9.366608314830e+04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.702858832608e+04 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 9.141708166107e+03 lambda=2.5000000000000001e-02 > > Line search: Cubically determined step, current gnorm > 8.847002105227e+03 lambda=1.2500000000000001e-02 > > 6 SNES Function norm 8.847002105227e+03 > > 0 KSP Residual norm 4.136774315749e+01 > > 0 KSP preconditioned resid norm 4.136774315749e+01 true resid norm > 8.847002105227e+03 ||r(i)||/||b|| 1.000000000000e+00 > > 1 KSP Residual norm 2.340140336645e-12 > > 1 KSP preconditioned resid norm 2.340140336645e-12 true resid norm > 6.952836046439e-10 ||r(i)||/||b|| 7.858974106416e-14 > > Linear solve converged due to CONVERGED_RTOL iterations 1 > > Line search: gnorm after quadratic fit 7.928904942575e+03 > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > 7 SNES Function norm 7.928904942575e+03 > > 0 KSP Residual norm 9.421715655897e+01 > > 0 KSP preconditioned resid norm 9.421715655897e+01 true resid norm > 7.928904942575e+03 ||r(i)||/||b|| 1.000000000000e+00 > > 1 KSP Residual norm 5.662350656880e-12 > > 1 KSP preconditioned resid norm 5.662350656880e-12 true resid norm > 1.323447274435e-09 ||r(i)||/||b|| 1.669142566370e-13 > > Linear solve converged due to CONVERGED_RTOL iterations 1 > > Line search: gnorm after quadratic fit 4.679455846837e+04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.024301325332e+04 lambda=5.0000000000000003e-02 > > Line search: Cubically determined step, current gnorm > 7.882357228991e+03 lambda=2.5000000000000001e-02 > > 8 SNES Function norm 7.882357228991e+03 > > 0 KSP Residual norm 3.101373992455e+01 > > 0 KSP preconditioned resid norm 3.101373992455e+01 true resid norm > 7.882357228991e+03 ||r(i)||/||b|| 1.000000000000e+00 > > 1 KSP Residual norm 1.176793992597e-12 > > 1 KSP preconditioned resid norm 1.176793992597e-12 true resid norm > 4.948698048884e-10 ||r(i)||/||b|| 6.278195602050e-14 > > Linear solve converged due to CONVERGED_RTOL iterations 1 > > Line search: Using full step: fnorm 7.882357228991e+03 gnorm > 5.263287196819e+03 > > 9 SNES Function norm 5.263287196819e+03 > > 0 KSP Residual norm 8.541947236232e+00 > > 0 KSP preconditioned resid norm 8.541947236232e+00 true resid norm > 5.263287196819e+03 ||r(i)||/||b|| 1.000000000000e+00 > > 1 KSP Residual norm 1.741221887649e-12 > > 1 KSP preconditioned resid norm 1.741221887649e-12 true resid norm > 9.735248249306e-10 ||r(i)||/||b|| 1.849651726242e-13 > > Linear solve converged due to CONVERGED_RTOL iterations 1 > > Line search: gnorm after quadratic fit 4.836381737060e+03 > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > 10 SNES Function norm 4.836381737060e+03 > > 0 KSP Residual norm 1.926518638579e+01 > > 0 KSP preconditioned resid norm 1.926518638579e+01 true resid norm > 4.836381737060e+03 ||r(i)||/||b|| 1.000000000000e+00 > > 1 KSP Residual norm 1.278653333162e-11 > > 1 KSP preconditioned resid norm 1.278653333162e-11 true resid norm > 1.211659620475e-08 ||r(i)||/||b|| 2.505301868938e-12 > > Linear solve converged due to CONVERGED_RTOL iterations 1 > > Line search: gnorm after quadratic fit 4.550187794983e+03 > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > 11 SNES Function norm 4.550187794983e+03 > > 0 KSP Residual norm 5.492305435155e+00 > > 0 KSP preconditioned resid norm 5.492305435155e+00 true resid norm > 4.550187794983e+03 ||r(i)||/||b|| 1.000000000000e+00 > > 1 KSP Residual norm 3.941029797735e-13 > > 1 KSP preconditioned resid norm 3.941029797735e-13 true resid norm > 2.123615113926e-10 ||r(i)||/||b|| 4.667093336823e-14 > > Linear solve converged due to CONVERGED_RTOL iterations 1 > > Line search: gnorm after quadratic fit 3.210238905481e+03 > > Line search: Quadratically determined step, > lambda=4.4544417493894700e-01 > > 12 SNES Function norm 3.210238905481e+03 > > 0 KSP Residual norm 7.578202966222e+00 > > 0 KSP preconditioned resid norm 7.578202966222e+00 true resid norm > 3.210238905481e+03 ||r(i)||/||b|| 1.000000000000e+00 > > 1 KSP Residual norm 3.800509410151e-12 > > 1 KSP preconditioned resid norm 3.800509410151e-12 true resid norm > 3.408323024026e-09 ||r(i)||/||b|| 1.061703855812e-12 > > Linear solve converged due to CONVERGED_RTOL iterations 1 > > Line search: gnorm after quadratic fit 2.924559961092e+03 > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > 13 SNES Function norm 2.924559961092e+03 > > 0 KSP Residual norm 5.076980628354e+00 > > 0 KSP preconditioned resid norm 5.076980628354e+00 true resid norm > 2.924559961092e+03 ||r(i)||/||b|| 1.000000000000e+00 > > 1 KSP Residual norm 1.468522311180e-13 > > 1 KSP preconditioned resid norm 1.468522311180e-13 true resid norm > 9.059064389128e-11 ||r(i)||/||b|| 3.097582032733e-14 > > Linear solve converged due to CONVERGED_RTOL iterations 1 > > Line search: gnorm after quadratic fit 2.389633730237e+03 > > Line search: Quadratically determined step, > lambda=2.1257217805235396e-01 > > 14 SNES Function norm 2.389633730237e+03 > > 0 KSP Residual norm 5.166598232781e+00 > > 0 KSP preconditioned resid norm 5.166598232781e+00 true resid norm > 2.389633730237e+03 ||r(i)||/||b|| 1.000000000000e+00 > > 1 KSP Residual norm 2.249406847764e-13 > > 1 KSP preconditioned resid norm 2.249406847764e-13 true resid norm > 4.780078098549e-11 ||r(i)||/||b|| 2.000339231098e-14 > > Linear solve converged due to CONVERGED_RTOL iterations 1 > > Line search: gnorm after quadratic fit 2.093485770827e+03 > > Line search: Quadratically determined step, > lambda=1.5993239844479040e-01 > > 15 SNES Function norm 2.093485770827e+03 > > 0 KSP Residual norm 8.445727235216e+00 > > 0 KSP preconditioned resid norm 8.445727235216e+00 true resid norm > 2.093485770827e+03 ||r(i)||/||b|| 1.000000000000e+00 > > 1 KSP Residual norm 1.917214128329e-13 > > 1 KSP preconditioned resid norm 1.917214128329e-13 true resid norm > 1.577089911021e-10 ||r(i)||/||b|| 7.533320421842e-14 > > Linear solve converged due to CONVERGED_RTOL iterations 1 > > Line search: gnorm after quadratic fit 1.967949189728e+03 > > Line search: Quadratically determined step, > lambda=1.0000000000000001e-01 > > 16 SNES Function norm 1.967949189728e+03 > > 0 KSP Residual norm 2.548962277036e+01 > > 0 KSP preconditioned resid norm 2.548962277036e+01 true resid norm > 1.967949189728e+03 ||r(i)||/||b|| 1.000000000000e+00 > > 1 KSP Residual norm 4.393171339150e-12 > > 1 KSP preconditioned resid norm 4.393171339150e-12 true resid norm > 6.268541493766e-10 ||r(i)||/||b|| 3.185316738097e-13 > > Linear solve converged due to CONVERGED_RTOL iterations 1 > > Line search: gnorm after quadratic fit 3.445905389608e+03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.129006719528e+03 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.969320033677e+03 lambda=1.8287150237426619e-02 > > Line search: Cubically determined step, current gnorm > 1.963119931876e+03 lambda=8.7403113229804347e-03 > > 17 SNES Function norm 1.963119931876e+03 > > 0 KSP Residual norm 1.189834379636e+02 > > 0 KSP preconditioned resid norm 1.189834379636e+02 true resid norm > 1.963119931876e+03 ||r(i)||/||b|| 1.000000000000e+00 > > 1 KSP Residual norm 3.213937715681e-11 > > 1 KSP preconditioned resid norm 3.213937715681e-11 true resid norm > 8.137767291258e-08 ||r(i)||/||b|| 4.145323553147e-11 > > Linear solve converged due to CONVERGED_RTOL iterations 1 > > Line search: gnorm after quadratic fit 1.329932469429e+05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.079971894561e+04 lambda=5.0000000000000003e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 4.672632539568e+03 lambda=2.5000000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 2.337320012333e+03 lambda=1.2500000000000001e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.989655494060e+03 lambda=3.7908486903933652e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.964061592872e+03 lambda=4.3979444116724767e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.963285343925e+03 lambda=9.8760011176842895e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.963156689078e+03 lambda=2.3385231527184855e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.963128672876e+03 lambda=5.6482781216089357e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.963122042807e+03 lambda=1.3692247365910180e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.963120443658e+03 lambda=3.3226543340386796e-07 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.963120056069e+03 lambda=8.0648305027594934e-08 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.963119962021e+03 lambda=1.9576315045380916e-08 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.963119939193e+03 lambda=4.7519586695347587e-09 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.963119933652e+03 lambda=1.1534950726729967e-09 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.963119932307e+03 lambda=2.8000026447574534e-10 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.963119931981e+03 lambda=6.7967445495582766e-11 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.963119931902e+03 lambda=1.6498100190994443e-11 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.963119931882e+03 lambda=4.0046243381676681e-12 > > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.963119931878e+03 lambda=9.7209812173761137e-13 > > Line search: unable to find good step length! After 19 tries > > Line search: fnorm=1.9631199318761367e+03, > gnorm=1.9631199318776339e+03, ynorm=1.1898343796305618e+02, > minlambda=9.9999999999999998e-13, lambda=9.7209812173761137e-13, initial > slope=-3.8538398668951751e+06 > > Nonlinear solve did not converge due to DIVERGED_LINE_SEARCH iterations 17 > -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener http://www.caam.rice.edu/~mk51/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From bcyee at umich.edu Wed Aug 30 16:42:53 2017 From: bcyee at umich.edu (Ben Yee) Date: Wed, 30 Aug 2017 17:42:53 -0400 Subject: [petsc-users] Red-black block Jacobi in PETSc? In-Reply-To: References: <871snthgt6.fsf@jedbrown.org> Message-ID: I am interested in implementing it in the SOR framework. My ultimate goal is to find something that performs well for my problem, and I think I have enough evidence from my simple 1D codes that it should work. If I'm going to assess performance, I think it would be good to implement it reasonably optimally. The manual page for PCSOR says that it is "Not a true parallel SOR, in parallel this implementation corresponds to block Jacobi with SOR on each block". If I'm reading this correctly, then that description sounds like what I want to do except that it is missing the coloring scheme -- is that correct? If that is correct, then is there a way to define a block size on a MPIAIJ matrix, or would I have to use a BAIJ matrix? (With BJACOBI, there's the set total number of blocks function for defining the block sizes. Is there something equivalent for PCSOR?) Also, could you provide a brief overview of how I should go about altering SOR to do the coloring? Thanks! On Tue, Aug 29, 2017 at 11:35 PM, Barry Smith wrote: > > > On Aug 29, 2017, at 10:31 PM, Jed Brown wrote: > > > > Barry Smith writes: > > > >> Ok, you should be using the BAIJ matrix it supports point-block Jacobi > and point-block Gauss-Seidel. > >> > >> We do not have a red-black Jacobi/Gauss-Seidel but you could easily > add it. You will add it, not by using a any shell objects but by adding > functionality to the PCPBJACOBI code in PETSc which is in > src/ksp/pc/impls/pbjacobi/pbjacobi.c > >> > >> First you will need to add a routine to supply the colors (make it > general for any number of colors since the code is basically the same as > for only two colors) call it say > >> > >> PCPBJacobiSetColors(PC pc,PetscInt number of colors, PetscInt > *sizeofeachcolor, PetscInt **idsforeachcolor); > >> > >> you will have to add additional fields in PC_PBJacobi to contain this > information. > >> > >> Then copy the static PetscErrorCode PCApply_PBJacobi_N(PC pc,Vec x,Vec > y) for your block size N (for example 3) and modify it to do what you > want, so for example > >> > >> static PetscErrorCode PCApply_PBJacobi_2_Color(PC pc,Vec x,Vec y) > >> { > >> PC_PBJacobi *jac = (PC_PBJacobi*)pc->data; > >> PetscErrorCode ierr; > >> PetscInt i,m = jac->mbs; > >> const MatScalar *diag = jac->diag; > >> PetscScalar x0,x1,*yy; > >> const PetscScalar *xx; > >> > >> PetscFunctionBegin; > >> if (!jac->b) { > >> ierr = VecDuplicate(x,&jac->b); > >> ierr = VecDuplicate(x,&jac->work); > >> } > >> > >> ierr = VecCopy(x,b);CHKERRQ(ierr); > >> for (j=0; jnumberofcolors; j++) { > >> > >> ierr = VecGetArrayRead(b,&xx);CHKERRQ(ierr); > >> ierr = VecGetArray(y,&yy);CHKERRQ(ierr); > >> > >> for (i=0; isizeofeachcolor[j]; i++) { > >> ii = jac->idsforeachcolor[j][i]; > >> diag = jac->diag + 4*ii; > >> x0 = xx[2*ii]; x1 = xx[2*ii+1]; > >> yy[2*ii] = diag[0]*x0 + diag[2]*x1; > >> yy[2*ii+1] = diag[1]*x0 + diag[3]*x1; > >> } > >> ierr = VecRestoreArrayRead(b,&xx);CHKERRQ(ierr); > >> ierr = VecRestoreArray(y,&yy);CHKERRQ(ierr); > >> > >> /* update residual */ > >> if (i < jac->sizeofeachcolor[j]-1) { > >> ierr = MatMult(pc->matrix,y,work2); > >> ierr = VecAYPX(b,-1,work1); > >> } > >> } > > > > Why this way instead of adding the functionality to SOR? This global > > residual update is horribly inefficient compared to merely computing the > > residual on each color. > > True, but if this is for theoretical studies of convergence and not > optimal performance it is easier. For example you do this and see the > convergence is much better with coloring than without and then conclude it > is worth spending the time to do it properly within an SOR framework. > > Barry > > > > >> PetscFunctionReturn(0); > >> } > >> > >> Finally in PCSetUp_PBJacobi() you would set the apply function pointer > to the "color" version if the user has provided the coloring information. > >> > >> Pretty simple. > >> > >> Barry > >> > >> > >>> On Aug 29, 2017, at 6:47 PM, Ben Yee wrote: > >>> > >>> I'm solving a coupled set of equations, so each "block" corresponds to > a set of unknowns for a particular spatial cell. The matrix is structured > such that all of the unknowns for a given spatial cell have adjacent global > matrix indices (i.e., they're next to each other in the global solution > vector). Effectively, I want to do red-black Gauss Seidel, but with > blocks. Alternatively, it's the same as applying block Jacobi for all the > red cells and then applying block Jacobi for all the black cells. > >>> > >>> The color of the block is determined from the geometry of the problem > which is stored in various structures in the code I'm working on, > independent of petsc. (Physically, I generally have a nice 3d cartesian > spatial grid and the coloring is just a checkerboard in that case.) > >>> > >>> The reason I want to do this is for research purposes. I've > implemented my own interpolation matrices for PCMG, and, in my simpler 1d > codes and convergence analyses, I've found that doing a red-black smoothing > significantly improved convergence for my particular problem (though I'm > aware that this generally leads to poor cache efficiency). > >>> > >>> On Aug 29, 2017 7:33 PM, "Barry Smith" wrote: > >>> > >>> Ben, > >>> > >>> Please explain more what you mean by "a red-black block Jacobi > smoother". What is your matrix structure? What are the blocks? How do you > decide which ones are which color? Why do you wish to use some a smoother. > >>> > >>> Barry > >>> > >>>> On Aug 29, 2017, at 6:19 PM, Ben Yee wrote: > >>>> > >>>> Hi, > >>>> > >>>> For the smoother in PCMG, I want to use a red-black block Jacobi > smoother. Is this available with the existing PETSc options? If so, how > do I designate which blocks are red and which are black? > >>>> > >>>> If it is not possible, what would be the best way to implement this? > Would I use KSPRICHARDSON+PCSHELL? > >>>> > >>>> Thanks! > >>>> > >>>> -- > >>>> Ben Yee > >>>> > >>>> NERS PhD Candidate, University of Michigan > >>>> B.S. Mech. & Nuclear Eng., U.C. Berkeley > >>> > >>> > > -- Ben Yee NERS PhD Candidate, University of Michigan B.S. Mech. & Nuclear Eng., U.C. Berkeley -------------- next part -------------- An HTML attachment was scrubbed... URL: