Re: [petsc-dev] Segmentation faults in MatMatMult & MatTransposeMatMult

2019-01-16 Thread Pierre Jolivet via petsc-dev
> On 16 Jan 2019, at 3:22 PM, Jed Brown wrote: > > Matthew Knepley writes: > >> On Wed, Jan 16, 2019 at 9:01 AM Jed Brown via petsc-dev < >> petsc-dev@mcs.anl.gov> wrote: >> >>> Pierre Jolivet via petsc-dev writes: >>> >>

[petsc-dev] Segmentation faults in MatMatMult & MatTransposeMatMult

2019-01-14 Thread Pierre Jolivet via petsc-dev
Hello, Is there any chance to get MatMatMult_MPIAIJ_MPIDense and MatTransposeMatMult_MPIAIJ_MPIDense fixed so that the attached program could run _with a single_ process? (I know, I could switch to SeqAIJ_SeqDense, but that is not an option I have right now) Thanks in advance, Pierre

Re: [petsc-dev] Segmentation faults in MatMatMult & MatTransposeMatMult

2019-01-14 Thread Pierre Jolivet via petsc-dev
eplace > ierr = MatSetType(B, MATMPIDENSE)i;CHKERRQ(ierr); > to > ierr = MatSetType(B, MATDENSE)i;CHKERRQ(ierr); > > Then add > MatSeqAIJSetPreallocation() > MatSeqDenseSetPreallocation() > > Hong > > On Mon, Jan 14, 2019 at 2:51 PM Pierre Jolivet via petsc-dev > mai

Re: [petsc-dev] Segmentation faults in MatMatMult & MatTransposeMatMult

2019-01-14 Thread Pierre Jolivet via petsc-dev
Thanks, Pierre > https://www.mcs.anl.gov/petsc/petsc-current/docs/manualpages/Mat/MatXAIJSetPreallocation.html > > <https://www.mcs.anl.gov/petsc/petsc-current/docs/manualpages/Mat/MatXAIJSetPreallocation.html> > > Pierre Jolivet via petsc-dev <mailto:petsc-dev@mcs.an

Re: [petsc-dev] Segmentation faults in MatMatMult & MatTransposeMatMult

2019-01-15 Thread Pierre Jolivet via petsc-dev
= MatSetType(B, MATMPIDENSE)i;CHKERRQ(ierr); >> to >> ierr = MatSetType(B, MATDENSE)i;CHKERRQ(ierr); >> >> Then add >> MatSeqAIJSetPreallocation() >> MatSeqDenseSetPreallocation() >> >> Hong >> >> On Mon, Jan 14, 2019 at 2:51 PM

Re: [petsc-dev] Segmentation faults in MatMatMult & MatTransposeMatMult

2019-01-15 Thread Pierre Jolivet via petsc-dev
> On 15 Jan 2019, at 9:40 AM, Dave May > <mailto:dave.mayhe...@gmail.com>> wrote: >> >> >> >> On Tue, 15 Jan 2019 at 05:18, Pierre Jolivet via petsc-dev >> mailto:petsc-dev@mcs.anl.gov>> wrote: >> Cf. the end of my sentence: "(I know,

Re: [petsc-dev] Faulty logic in MatHYPRESetPreallocation?

2019-01-03 Thread Pierre Jolivet via petsc-dev
5 from mat tests. Probably Pierre's fix will curate that problem too. StefanoIl giorno Sab 22 Dic 2018, 06:30 Smith, Barry F. <bsm...@mcs.anl.gov> ha scritto:    Stefeno,     Doe this look right to you?     Thanks     Barry > On Dec 17, 2018, at 3:18 AM, Pierre Jolivet via petsc

Re: [petsc-dev] MatNest and inner KSP

2018-12-19 Thread Pierre Jolivet via petsc-dev
t. Thanks, Pierre > After PCSetUp, you can access the inner solves, see e.g. > https://bitbucket.org/petsc/petsc/src/4ddd364d454d7bce974e92e0b5bd4f4516dbff02/src/ksp/pc/impls/bddc/bddc.c#lines-2715 >> On Dec 19, 2018, at 9:01 AM, Pierre Jolivet via petsc-dev >> wrote: >>

[petsc-dev] MatNest and inner KSP

2018-12-18 Thread Pierre Jolivet via petsc-dev
Hello, I have a PCFIELDSPLIT where the fields are defined by a MATNEST “decomposition”. Right now, I am first defining the KSP of the diagonal blocks of the MATNEST, which are themselves PCFIELDSPLIT, then creating the Mat itself, and eventually I’d like to solve systems with the complete

[petsc-dev] SNESSolve and changing dimensions

2019-04-03 Thread Pierre Jolivet via petsc-dev
I’d like to do mesh adaptation in a Newton loop. I’m using a SNES with SNESSetFunction and SNESSetJacobian. My first question is: may the dimension of the linear systems change throughout the nonlinear iterations? If so, what are the proper things to do? I tried to do as Stefano in MFEM and use

Re: [petsc-dev] MatNest and FieldSplit

2019-03-24 Thread Pierre Jolivet via petsc-dev
don’t know if this makes more or less sense… sorry :\ Thanks, Pierre > On 24 Mar 2019, at 8:42 PM, Matthew Knepley wrote: > > On Sat, Mar 23, 2019 at 9:12 PM Pierre Jolivet via petsc-dev > mailto:petsc-dev@mcs.anl.gov>> wrote: > I’m trying to figure out why both so

Re: [petsc-dev] SNESSolve and changing dimensions

2019-04-03 Thread Pierre Jolivet via petsc-dev
uch to ask of PETSc to continue working without any further information from the application. Thanks, Pierre > Thanks, > > Matt > > Thanks, > Pierre > >> Il giorno mer 3 apr 2019 alle ore 14:52 Matthew Knepley via petsc-dev >> mailto:petsc-dev@mcs.anl.go

Re: [petsc-dev] SNESSolve and changing dimensions

2019-04-03 Thread Pierre Jolivet via petsc-dev
r 2019 alle ore 14:52 Matthew Knepley via petsc-dev > mailto:petsc-dev@mcs.anl.gov>> ha scritto: > On Wed, Apr 3, 2019 at 5:43 AM Pierre Jolivet via petsc-dev > mailto:petsc-dev@mcs.anl.gov>> wrote: > I’d like to do mesh adaptation in a Newton loop. > I’m using a SNES with SN

Re: [petsc-dev] MatNest and FieldSplit

2019-03-25 Thread Pierre Jolivet via petsc-dev
). > > I may understand waht you are doing. > Fieldsplit calls MatGetSubMatrix() which can copy values, depending on the > implementation, > so changing values in the original matrix may or may not change it in the PC. > >Matt > > I don’t know if this makes m

[petsc-dev] MatNest and FieldSplit

2019-03-24 Thread Pierre Jolivet via petsc-dev
I’m trying to figure out why both solutions are not consistent in the following example. Is what I’m doing complete nonsense? Thanks in advance for your help, Pierre nest.c Description: Binary data

[petsc-dev] KSPMonitor and petsc4py

2019-02-25 Thread Pierre Jolivet via petsc-dev
I’m not sure this is the expected behavior. Is it? $ git diff ex100.py diff --git a/src/ksp/ksp/examples/tutorials/ex100.py b/src/ksp/ksp/examples/tutorials/ex100.py index dbb3f8e012..051637ce1d 100644 --- a/src/ksp/ksp/examples/tutorials/ex100.py +++ b/src/ksp/ksp/examples/tutorials/ex100.py @@

[petsc-dev] Transpose and AXPY

2019-04-09 Thread Pierre Jolivet via petsc-dev
We are trying to solve a generalized eigenvalue problem with -st_type sinvert using a MATNEST as a RHS and a nonzero shift. Some Mats in the MATNEST are either created with MatCreateHermitianTranspose or MatCreateTranspose. MatAXPY (needed by -st_type sinvert) is failing us because there is

Re: [petsc-dev] MatNest and FieldSplit

2019-04-14 Thread Pierre Jolivet via petsc-dev
may sound really trivial but I’m lost in limbo right now. When everything is not wrapped inside an outer PCFIELDSPLIT, everything just work. Thanks, Pierre > On 25 Mar 2019, at 6:57 PM, Pierre Jolivet via petsc-dev > wrote: > > Thanks, this makes (slightly) more sense to me kn

Re: [petsc-dev] MatNest and FieldSplit

2019-04-15 Thread Pierre Jolivet via petsc-dev
eed to get the KSP prefix followed up by some string comparison to get the actual IS prefix, whereas I know the position of the KSP in the PC_FieldSplitLink. Thanks, Pierre > On 14 Apr 2019, at 10:54 PM, Pierre Jolivet via petsc-dev > wrote: > > I think I figured out what m

Re: [petsc-dev] MatNest and FieldSplit

2019-04-15 Thread Pierre Jolivet via petsc-dev
> On 15 Apr 2019, at 2:17 PM, Matthew Knepley <mailto:knep...@gmail.com>> wrote: > > On Mon, Apr 15, 2019 at 5:03 AM Pierre Jolivet via petsc-dev > mailto:petsc-dev@mcs.anl.gov>> wrote: > OK, my solver is now working properly with a call to > PetscObje

Re: [petsc-dev] SNESSetKSP and SNESDestroy

2019-05-30 Thread Pierre Jolivet via petsc-dev
t;> On May 30, 2019, at 9:51 AM, Stefano Zampini via petsc-dev >>>> wrote: >>>> >>>> I meant SNESDestroy should call KSPDestroy >>>> >>>> The reason for having the XXXReset methods called by the XXXDestroy is >>>>

Re: [petsc-dev] SNESSetKSP and SNESDestroy

2019-05-30 Thread Pierre Jolivet via petsc-dev
>>> >>> >>> >>> >>>> On May 30, 2019, at 9:51 AM, Stefano Zampini via petsc-dev >>>> wrote: >>>> >>>> I meant SNESDestroy should call KSPDestroy >>>> >>>> The reason for having the XXXRe

[petsc-dev] SNESSetKSP and SNESDestroy

2019-05-30 Thread Pierre Jolivet via petsc-dev
Hello, I’m doing a continuation loop with something like: KSP ksp; KSPSetUp(ksp); while(cond) { SNES snes; SNESCreate(); SNESSetKSP(snes, ); SNESSolve(snes); SNESDestroy(); } For the first iteration, everything is OK. After that, it looks like SNESDestroy

Re: [petsc-dev] SNESSetKSP and SNESDestroy

2019-05-30 Thread Pierre Jolivet via petsc-dev
> On 30 May 2019, at 2:42 PM, Matthew Knepley wrote: > > On Thu, May 30, 2019 at 6:08 AM Pierre Jolivet via petsc-dev > mailto:petsc-dev@mcs.anl.gov>> wrote: > Hello, > I’m doing a continuation loop with something like: > KSP ksp; > KSPSetUp(ksp); >

Re: [petsc-dev] SNESSetKSP and SNESDestroy

2019-05-30 Thread Pierre Jolivet via petsc-dev
ut the library. >> >>> On May 30, 2019, at 3:59 PM, Stefano Zampini >>> wrote: >>> >>> I think snes reset should call ksp destroy. I don't see the case for which >>> this can lead to troubles >>> >>> Il Gio

[petsc-dev] Unevenly distributed MatNest and FieldSplit

2019-06-12 Thread Pierre Jolivet via petsc-dev
Hello, We are using a SNES to solve a steady-state FSI problem. The operator is defined as a MatNest with multiple fields. Some submatrices are entirely defined on a subset of processes (but they are still created on the same communicator as the MatNest). The preconditioner is defined as a

[petsc-dev] TAOIPM v. IPOPT

2019-06-15 Thread Pierre Jolivet via petsc-dev
Hello, I’m trying to solve the following constrained problem: min x0*x3*(x0+x1+x2) + x2 s.t.x0*x1*x2*x3 >= 25 (a) x0**2 + x1**2 + x2**2 + x3**2 = 40 1 <= x0, x1, x2, x3 <= 5 I modified src/tao/constrained/examples/tutorials/toy.c (you can git diff the attached file) to try

Re: [petsc-dev] Unevenly distributed MatNest and FieldSplit

2019-06-13 Thread Pierre Jolivet via petsc-dev
make > clear where the two sets of processes branch. > > Good luck, > > Barry > > >> On Jun 12, 2019, at 1:44 AM, Pierre Jolivet via petsc-dev >> wrote: >> >> Hello, >> We are using a SNES to solve a steady-state FSI problem. >> The operator is

Re: [petsc-dev] circular dependencies SLEPc

2019-07-08 Thread Pierre Jolivet via petsc-dev
Hello, I’m not sure what’s the status about this issue. I’m trying to register a PC that is using EPSSolve during PCSetUp, but it’s falling because of undefined references to EPSSomething when linking libpetsc.so How could I fix this, appart from removing my PC from PETSc and compiling this as a

Re: [petsc-dev] alternatives to cygwin on Windows with PETSc

2019-07-02 Thread Pierre Jolivet via petsc-dev
> On 2 Jul 2019, at 12:26 AM, Smith, Barry F. via petsc-dev > wrote: > > > https://bitbucket.org/petsc/petsc/pull-requests/1836/installationhtml-edited-online-with/diff > > I try to provide a better guild for Windows possibilities without windows > compilers. (Could probably do with some

Re: [petsc-dev] SeqSBAIJ v. MPISBAIJ

2019-08-02 Thread Pierre Jolivet via petsc-dev
it is a bug, working on it now. On Aug 1, 2019, at 9:13 AM, Pierre Jolivet via petsc-dev wrote:Hello,The attached example is a little confusing for me.How come I don’t get the same matrix out-of-the-box?For me, the “correct” matrix is the SeqSBAIJ, how can I get MatMPISBAIJSetPreallocationCSR to assemble

Re: [petsc-dev] Sequential external packages and MPI

2019-08-22 Thread Pierre Jolivet via petsc-dev
> >> On Aug 22, 2019, at 1:03 AM, Pierre Jolivet via petsc-dev >> wrote: >> >> >> >>> On 22 Aug 2019, at 7:42 AM, Balay, Satish wrote: >>> >>> On Thu, 22 Aug 2019, Pierre Jolivet via petsc-dev wrote: >>> >>

[petsc-dev] Sequential external packages and MPI

2019-08-21 Thread Pierre Jolivet via petsc-dev
Hello, PETSc is linking “sequential” libraries with MPI libraries. $ otool -L libmetis.dylib /usr/local/opt/mpich/lib/libmpi.12.dylib (compatibility version 14.0.0, current version 14.7.0) $ otool -L libfftw3.dylib /usr/local/opt/mpich/lib/libmpi.12.dylib (compatibility version

Re: [petsc-dev] Sequential external packages and MPI

2019-08-22 Thread Pierre Jolivet via petsc-dev
> On 22 Aug 2019, at 7:42 AM, Balay, Satish wrote: > > On Thu, 22 Aug 2019, Pierre Jolivet via petsc-dev wrote: > >> Hello, >> PETSc is linking “sequential” libraries with MPI libraries. >> $ otool -L libmetis.dylib >> /usr/local/opt/mpich/lib/li

[petsc-dev] SetPreallocationCSR

2019-08-24 Thread Pierre Jolivet via petsc-dev
Hello, Out of the three SetPreallocationCSR implementations (for MPIAIJ, MPIBAIJ, and MPISBAIJ), only MPIAIJ is forcing MAT_NO_OFF_PROC_ENTRIES to PETSC_TRUE before the final AssemblyBegin/AssemblyEnd: - AIJ

Re: [petsc-dev] SetPreallocationCSR

2019-08-24 Thread Pierre Jolivet via petsc-dev
nd it doesn’t seem to break down my PC, so I’ll push this in a branch (and create the according MR when we receive your green light). Thanks, Pierre > Barry > >> On Aug 24, 2019, at 7:55 AM, Pierre Jolivet via petsc-dev >> wrote: >> >> Hello, >> Out of the

Re: [petsc-dev] MAT_HERMITIAN

2019-09-11 Thread Pierre Jolivet via petsc-dev
(Putting back petsc-dev on c/c) I don’t think you are the one that needs to do the changes. There should be clarifications from the PETSc side of things, first. From the man page your are quoting (https://www.mcs.anl.gov/petsc/petsc-current/docs/manualpages/Mat/MATSEQSBAIJ.html

Re: [petsc-dev] MAT_HERMITIAN

2019-09-11 Thread Pierre Jolivet via petsc-dev
Nevermind, this is the wrong fix. The proper fix is in PETSc. It should not error out if the matrix is also symmetric. Indeed, complex symmetric Hermitian => complex with no imaginary part. Thus all operations like MatMult, MatMultHermitianTranspose, Cholesky… will work for bs > 1, since all is

Re: [petsc-dev] MAT_HERMITIAN

2019-09-13 Thread Pierre Jolivet via petsc-dev
n_set = PETSC_TRUE; > #endif >break; > case MAT_HERMITIAN: >mat->hermitian = flg; >if (flg) mat->structurally_symmetric = PETSC_TRUE; >mat->hermitian_set = PETSC_TRUE; >mat->structurally_symmetric_set = flg; > #if !defined(PETSC_U

Re: [petsc-dev] MAT_HERMITIAN

2019-09-14 Thread Pierre Jolivet via petsc-dev
t;>> } else SETERRQ(PETSC_COMM_SELF,PETSC_ERR_SUP,"No support for Hermitian >>> with block size greater than 1"); >>> #endif >>> >>> >>> >>>case MAT_SYMMETRIC: >>> mat->symmetric = flg; >>> if (flg) ma

[petsc-dev] fieldsplit + composite + ksp

2019-09-18 Thread Pierre Jolivet via petsc-dev
Hello, I’m solving the following dummy system http://jolivet.perso.enseeiht.fr/composite_ksp.tar.gz [A, B];[C, D], with a PCFIELDSPLIT. For the PC of D, I’m using a PCCOMPOSITE with two sub PCs. One of which is a PCKSP. Could you please

Re: [petsc-dev] fieldsplit + composite + ksp

2019-09-18 Thread Pierre Jolivet via petsc-dev
> On 18 Sep 2019, at 3:48 PM, Matthew Knepley wrote: > > On Wed, Sep 18, 2019 at 2:49 AM Pierre Jolivet via petsc-dev > mailto:petsc-dev@mcs.anl.gov>> wrote: > Hello, > I’m solving the following dummy system > http://jolivet.perso.enseeiht.fr/co

Re: [petsc-dev] fieldsplit + composite + ksp

2019-09-18 Thread Pierre Jolivet via petsc-dev
gt;> On Wed, Sep 18, 2019 at 2:49 AM Pierre Jolivet via petsc-dev >> mailto:petsc-dev@mcs.anl.gov>> wrote: >> Hello, >> I’m solving the following dummy system >> http://jolivet.perso.enseeiht.fr/composite_ksp.tar.gz >> <http://jolivet.perso.enseei

[petsc-dev] PCREDUNDANT

2019-07-28 Thread Pierre Jolivet via petsc-dev
Hello, I’m facing multiple issues with PCREDUNDANT and MATMPISBAIJ: 1) https://www.mcs.anl.gov/petsc/petsc-current/src/mat/impls/sbaij/mpi/mpisbaij.c.html#line3354 shouldn’t this be sum != N? I’m

Re: [petsc-dev] PCREDUNDANT

2019-07-28 Thread Pierre Jolivet via petsc-dev
> On 28 Jul 2019, at 3:02 PM, Mark Adams wrote: > > > On Sun, Jul 28, 2019 at 2:54 AM Pierre Jolivet via petsc-dev > mailto:petsc-dev@mcs.anl.gov>> wrote: > Hello, > I’m facing multiple issues with PCREDUNDANT and MATMPISBAIJ: > 1) > https://www.mcs.anl.gov/

[petsc-dev] ISLocalToGlobalMappingGetInfo

2019-08-08 Thread Pierre Jolivet via petsc-dev
Hello, When I use ISLocalToGlobalMappingGetInfo, e.g., in src/ksp/ksp/examples/tutorials/ex71.c ISLocalToGlobalMappingGetInfo(map, , , , ), I get the following value for nproc: - with 1 process: 0 - with 2 processes: 2 In the source code, it says that nproc is the “number of processors that are

Re: [petsc-dev] ISLocalToGlobalMappingGetInfo

2019-08-09 Thread Pierre Jolivet via petsc-dev
check the entries for that "extra" >>> connection, are they all actual meaningful connections. The code that fills >>> up these data structures is somewhat involved. >>> >>> Barry >>> >>> >>>> On Aug 8, 2019, at 9:39 AM, Pier

Re: [petsc-dev] ISLocalToGlobalMappingGetInfo

2019-08-09 Thread Pierre Jolivet via petsc-dev
> On 9 Aug 2019, at 9:35 AM, Pierre Jolivet via petsc-dev > wrote: > > Actually, I don’t think it is a bug, but rather an undocumented feature. > Someone clearly knew what they were doing when writing this: > https://www.mcs.anl.gov/petsc/petsc-current/src/vec/is/utils/isltog.c.ht

Re: [petsc-dev] ISLocalToGlobalMappingGetInfo

2019-08-08 Thread Pierre Jolivet via petsc-dev
t; Barry > > >> On Aug 8, 2019, at 9:39 AM, Pierre Jolivet via petsc-dev >> wrote: >> >> Hello, >> When I use ISLocalToGlobalMappingGetInfo, e.g., in >> src/ksp/ksp/examples/tutorials/ex71.c ISLocalToGlobalMappingGetInfo(map, >> , , , ), I

[petsc-dev] SeqSBAIJ v. MPISBAIJ

2019-08-01 Thread Pierre Jolivet via petsc-dev
Hello, The attached example is a little confusing for me. How come I don’t get the same matrix out-of-the-box? For me, the “correct” matrix is the SeqSBAIJ, how can I get MatMPISBAIJSetPreallocationCSR to assemble the same matrix? Do I have to resort to first assembling SeqSBAIJ matrices and then

Re: [petsc-dev] Fwd: [mumps-users] MUMPS MPI (5.2.1) does not compile

2019-07-22 Thread Pierre Jolivet via petsc-dev
? >> >> How does any of them resolve the problem with ifort failing to compile? >> >> Barry >> >> >>> On Jul 22, 2019, at 1:28 PM, Pierre Jolivet via petsc-dev >>> wrote: >>> >>> We are having trouble compiling

[petsc-dev] Fwd: [mumps-users] MUMPS MPI (5.2.1) does not compile

2019-07-22 Thread Pierre Jolivet via petsc-dev
We are having trouble compiling git.mumps with similar errors (using ifort 2017, yikes).Could the forwarded patches be applied to petsc/pkg-mumps, please?Thanks in advance (and sorry if this should be handled @petsc-maint),PierreBegin forwarded message:From: "Antonio Trande" (anto.tra...@gmail.com

[petsc-dev] How to check that MatMatMult is available

2019-09-19 Thread Pierre Jolivet via petsc-dev
Hello, Given a Mat A, I’d like to know if there is an implementation available for doing C=A*B I was previously using MatHasOperation(A, MATOP_MATMAT_MULT, ) but the result is not correct in at least two cases: 1) A is a MATTRANSPOSE and the underlying Mat B=A^T has a MatTransposeMatMult

[petsc-dev] Mixing separate and shared ouputs

2019-09-28 Thread Pierre Jolivet via petsc-dev
Hello, If I put something like this in src/ksp/ksp/examples/tutorials/ex12.c args: -ksp_gmres_cgs_refinement_type refine_always -ksp_type {{cg gmres}separate output} -pc_type {{jacobi bjacobi lu}separate output} I get # success 9/13 tests (69.2%) Now args:

Re: [petsc-dev] Broken MatMatMult_MPIAIJ_MPIDense

2019-09-23 Thread Pierre Jolivet via petsc-dev
Hong, You should probably cherry pick https://gitlab.com/petsc/petsc/commit/93d7d1d6d29b0d66b5629a261178b832a925de80?merge_request_iid=2069 (and remove the MatNest part). This fixes a

Re: [petsc-dev] How to check that MatMatMult is available

2019-09-20 Thread Pierre Jolivet via petsc-dev
> On 20 Sep 2019, at 7:36 AM, Jed Brown <mailto:j...@jedbrown.org>> wrote: > > Pierre Jolivet via petsc-dev <mailto:petsc-dev@mcs.anl.gov>> writes: > >> Hello, >> Given a Mat A, I’d like to know if there is an implementation available for

[petsc-dev] Broken MatMatMult_MPIAIJ_MPIDense

2019-09-22 Thread Pierre Jolivet via petsc-dev
Jed,I’m not sure how easy it is to put more than a few lines of code on GitLab, so I’ll just send the (tiny) source here, as a follow-up of our discussion https://gitlab.com/petsc/petsc/merge_requests/2069#note_220229648.Please find attached a .cpp showing the brokenness of C=A*B with A of type

Re: [petsc-dev] Broken MatMatMult_MPIAIJ_MPIDense

2019-09-22 Thread Pierre Jolivet via petsc-dev
Monday and maybe get a clean into > a MR so it gets into the release? > > Thanks > > > Barry > > > > > >> On Sep 22, 2019, at 11:12 AM, Pierre Jolivet >> wrote: >> >> >>> On 22 Sep 2019, at 6:03 PM, Smith, Barry F. wro

Re: [petsc-dev] Broken MatMatMult_MPIAIJ_MPIDense

2019-09-22 Thread Pierre Jolivet via petsc-dev
matrix should be >>>> added to the changes document. >>>> >>>> Sorry for the difficulties. We have trouble testing all the combinations >>>> of possible usage, even a coverage tool would not have indicated a >>>> problems the lack of lda

Re: [petsc-dev] Broken MatMatMult_MPIAIJ_MPIDense

2019-09-22 Thread Pierre Jolivet via petsc-dev
Sep 2019, at 5:04 PM, Zhang, Hong wrote: > > I'll check it tomorrow. > Hong > > On Sun, Sep 22, 2019 at 1:04 AM Pierre Jolivet via petsc-dev > mailto:petsc-dev@mcs.anl.gov>> wrote: > Jed, > I’m not sure how easy it is to put more than a few lines of code on GitLab

Re: [petsc-dev] Broken MatMatMult_MPIAIJ_MPIDense

2019-09-22 Thread Pierre Jolivet via petsc-dev
> On 22 Sep 2019, at 6:03 PM, Smith, Barry F. wrote: > > > >> On Sep 22, 2019, at 10:14 AM, Pierre Jolivet via petsc-dev >> wrote: >> >> FWIW, I’ve fixed MatMatMult and MatTransposeMatMult here >> https://gitlab.com/petsc/petsc/commi

Re: [petsc-dev] Right-preconditioned GMRES

2019-11-07 Thread Pierre Jolivet via petsc-dev
8:16 PM, Smith, Barry F. wrote: >>>>> >>>>> >>>>> Is this one process with one subdomain? (And hence no meaningful overlap >>>>> since there is nothing to overlap?) And you expect to get the "exact" >>>>> answer on

Re: [petsc-dev] Right-preconditioned GMRES

2019-11-06 Thread Pierre Jolivet via petsc-dev
and >>> basic and none] -ksp_monitor_true_solution and send the output for the >>> three cases. >>> >>> For kicks you can also try FGMRES (which always uses right preconditioning) >>> to see if the same problem appears. >>> >>> Bar

Re: [petsc-dev] Right-preconditioned GMRES

2019-11-06 Thread Pierre Jolivet via petsc-dev
triction but discards them when > doing interpolation, which leads to an unsymmetric preconditioned operator. Of course. What’s your point? Thanks, Pierre > Fande, > > > > On Wed, Nov 6, 2019 at 11:13 AM Pierre Jolivet via petsc-dev > mailto:petsc-dev@mcs.anl.gov&g

Re: [petsc-dev] Right-preconditioned GMRES

2019-11-06 Thread Pierre Jolivet via petsc-dev
> On 6 Nov 2019, at 7:44 PM, Matthew Knepley wrote: > > On Wed, Nov 6, 2019 at 1:32 PM Pierre Jolivet via petsc-dev > mailto:petsc-dev@mcs.anl.gov>> wrote: >> On 6 Nov 2019, at 7:30 PM, Fande Kong > <mailto:fdkong...@gmail.com>> wrote: >

Re: [petsc-dev] PetscLayoutFindOwner and PetscLayoutFindOwnerIndex

2019-10-25 Thread Pierre Jolivet via petsc-dev
t; On Oct 16, 2019, at 5:19 AM, Pierre Jolivet via petsc-dev >> wrote: >> >> Hello, >> These two functions use a parameter “owner” of type PetscInt*. >> Shouldn’t this be PetscMPIInt*? >> This implies changes left and right, so I want to check I’m not pushing an >> incorrect MR. >> >> Thanks, >> Pierre >

Re: [petsc-dev] PetscLayoutFindOwner and PetscLayoutFindOwnerIndex

2019-10-28 Thread Pierre Jolivet via petsc-dev
https://gitlab.com/petsc/petsc/merge_requests// <https://gitlab.com/petsc/petsc/merge_requests//> > On 24 Oct 2019, at 4:47 PM, Smith, Barry F. wrote: > > > These routines should be fixed. > > >> On Oct 16, 2019, at 5:19 AM, Pierre Jolivet via pets

Re: [petsc-dev] PetscLayoutFindOwner and PetscLayoutFindOwnerIndex

2019-10-16 Thread Pierre Jolivet via petsc-dev
; > On Wed, Oct 16, 2019 at 5:19 AM Pierre Jolivet via petsc-dev > mailto:petsc-dev@mcs.anl.gov>> wrote: > Hello, > These two functions use a parameter “owner” of type PetscInt*. > Shouldn’t this be PetscMPIInt*? > This implies changes left and right, so I want to check I’m not pushing an > incorrect MR. > > Thanks, > Pierre

Re: [petsc-dev] BlockGetIndices and GetBlockIndices

2019-10-20 Thread Pierre Jolivet via petsc-dev
lMappingCreate()). > There is no universal concept of a block size in IS (despite the crap that > other people put in using PetscLayout which has nothing to do with ISBlock > and is completely buggy.) nor should there be or is there a need for. OK then. Thanks, Pierre &

Re: [petsc-dev] ksp_error_if_not_converged in multilevel solvers

2019-10-20 Thread Pierre Jolivet via petsc-dev
d remember the second option. > > I'm not really excited by any of my proposed solutions. > > Thoughts? > > > Barry > > > > >> On Oct 20, 2019, at 7:55 AM, Pierre Jolivet via petsc-dev >> wrote: >> >> Hello, >> I’m trying to get multilev

Re: [petsc-dev] BlockGetIndices and GetBlockIndices

2019-10-21 Thread Pierre Jolivet via petsc-dev
for optimizations then you HAVE to go through >>> the subclasses by design and nature (for example VecScatterCreate() takes >>> advantage of the structure of the IS as does >>> ISLocalToGlobalMappingCreate()). There is no universal concept of a block

Re: [petsc-dev] BlockGetIndices and GetBlockIndices

2019-10-20 Thread Pierre Jolivet via petsc-dev
mapping) Thanks, Pierre > >> On Oct 16, 2019, at 2:50 AM, Pierre Jolivet via petsc-dev >> wrote: >> >> Hello, >> I’m trying to understand what is the rationale for naming a function >> ISBlockGetIndices and another ISLocalToGlobalMappingGetBlockIn

Re: [petsc-dev] ksp_error_if_not_converged in multilevel solvers

2019-10-21 Thread Pierre Jolivet via petsc-dev
> On 21 Oct 2019, at 3:04 PM, Jed Brown wrote: > > Pierre Jolivet via petsc-dev writes: > >> On Oct 20, 2019, at 6:07 PM, "Smith, Barry F." wrote: >> >>> >>> The reason the code works this way is that normally >>> -ksp_err

Re: [petsc-dev] BlockGetIndices and GetBlockIndices

2019-10-21 Thread Pierre Jolivet via petsc-dev
> On 21 Oct 2019, at 3:01 PM, Jed Brown wrote: > > Pierre Jolivet via petsc-dev writes: > >>> On 21 Oct 2019, at 7:52 AM, Smith, Barry F. wrote: >>> >>> >>> >>>> On Oct 21, 2019, at 12:23 AM, Pierre Jolivet >>>> w

[petsc-dev] BlockGetIndices and GetBlockIndices

2019-10-16 Thread Pierre Jolivet via petsc-dev
Hello, I’m trying to understand what is the rationale for naming a function ISBlockGetIndices and another ISLocalToGlobalMappingGetBlockIndices (BlockGet vs. GetBlock). Also, it looks to me like the implementation of ISBlockGetIndices is somehow less versatile than

[petsc-dev] PetscLayoutFindOwner and PetscLayoutFindOwnerIndex

2019-10-16 Thread Pierre Jolivet via petsc-dev
Hello, These two functions use a parameter “owner” of type PetscInt*. Shouldn’t this be PetscMPIInt*? This implies changes left and right, so I want to check I’m not pushing an incorrect MR. Thanks, Pierre

[petsc-dev] ksp_error_if_not_converged in multilevel solvers

2019-10-20 Thread Pierre Jolivet via petsc-dev
Hello, I’m trying to get multilevel solvers to error out when coarse levels are not converging, but I’m failing… Could someone either tell me if this is not possible to do so, or help me find what the problem in my options is, please? (in src/ksp/ksp/examples/tutorials) $ mpirun -n 8 ./ex71

Re: [petsc-dev] Broken MatMatMult_MPIAIJ_MPIDense

2019-09-22 Thread Pierre Jolivet via petsc-dev
t;> "In the special case where matrix B (and hence C) are dense you can create >>>> the correctly sized matrix C yourself and then call this routine with >>>> MAT_REUSE_MATRIX, rather than first having MatMatMult() create it for you." >>>> >&

Re: [petsc-dev] Broken MatMatMult_MPIAIJ_MPIDense

2019-09-22 Thread Pierre Jolivet via petsc-dev
phases (assuming the rest remains as is and is not changed to cache C). Thanks, Pierre > Hong > > On Sun, Sep 22, 2019 at 4:38 PM Pierre Jolivet via petsc-dev > mailto:petsc-dev@mcs.anl.gov>> wrote: > > >> On 22 Sep 2019, at 8:32 PM, Smith, Barry F. > <mailto

[petsc-dev] SNES_DIVERGED_TR_DELTA

2019-10-06 Thread Pierre Jolivet via petsc-dev
Hello, Shouldn’t there be a deprecation warning for this commit https://gitlab.com/petsc/petsc/commit/c1c6be5a2ecdf9c2ab80f7794960faf5930a5b23 instead of a compilation failure for people still using

Re: [petsc-dev] Right-preconditioned GMRES

2019-10-13 Thread Pierre Jolivet via petsc-dev
gt; > > On Sun, Oct 13, 2019 at 9:34 AM Mark Adams <mailto:mfad...@lbl.gov>> wrote: > Try -pc_asm_overlap 0 with ASM. > > And I trust the KO run works with 1 processor (direct solve) > > On Sun, Oct 13, 2019 at 3:41 AM Pierre Jolivet via petsc-dev >

Re: [petsc-dev] Right-preconditioned GMRES

2019-10-14 Thread Pierre Jolivet via petsc-dev
h always uses right preconditioning) > to see if the same problem appears. > > Barry > > >> On Oct 13, 2019, at 2:41 AM, Pierre Jolivet via petsc-dev >> wrote: >> >> Hello, >> I’m struggling to understand the following weirdness with PCASM with ex