Re: [petsc-users] MPI_Iprobe Error with MUMPS Solver on Multi-Nodes

2023-05-23 Thread Yann Jobic
If i may, you can use the command line option "-mat_mumps_icntl_4 2" MUMPS then gives infomations about the factorization step, such as the estimated needed memory. Best regards, Yann Le 5/23/2023 à 11:59 AM, Matthew Knepley a écrit : On Mon, May 22, 2023 at 10:42 PM Zongze Yang

Re: [petsc-users] realCoords for DOFs

2022-12-13 Thread Yann Jobic
;CHKERRV(ierr); On Tue, Dec 13, 2022 at 3:38 AM Yann Jobic <mailto:yann.jo...@univ-amu.fr>> wrote: Le 12/13/2022 à 2:04 AM, Mark Adams a écrit : > PETSc does not store the coordinates for high order elements (ie, the > "midside nodes").

Re: [petsc-users] realCoords for DOFs

2022-12-13 Thread Yann Jobic
It could really help me ! If i have the node coordinates in the reference element, then it's easy to project them to the real space. But i couldn't find a way to have them, so if you could give me some guidance, it could be really helpful. Thanks, Yann Mark On Mon, Dec 12, 2022 at 6:06 PM

Re: [petsc-users] realCoords for DOFs

2022-12-13 Thread Yann Jobic
Le 12/13/2022 à 5:43 AM, Matthew Knepley a écrit : On Mon, Dec 12, 2022 at 6:06 PM Yann Jobic <mailto:yann.jo...@univ-amu.fr>> wrote: Hi all, I'm trying to get the coords of the dofs of a DMPlex for a PetscFE discretization, for orders greater than 1. I'm struggli

[petsc-users] realCoords for DOFs

2022-12-12 Thread Yann Jobic
Hi all, I'm trying to get the coords of the dofs of a DMPlex for a PetscFE discretization, for orders greater than 1. I'm struggling to run dm/impls/plex/tutorials/ex8.c I've got the following error (with option -view_coord) : [0]PETSC ERROR: - Error Message

Re: [petsc-users] basis/basisDer/Jac in FE

2022-10-27 Thread Yann Jobic
There is this factor also in front of the rectangle, which should 1/4 for a unit rectangle of dim 2, but it's also 0.5. Thanks, Yann Le 10/27/2022 à 6:23 PM, Mark Adams a écrit : Area of a unit triangle is (1x1)/2 I would guess. On Thu, Oct 27, 2022 at 11:32 AM Yann Jobic <mailto:yann

[petsc-users] basis/basisDer/Jac in FE

2022-10-27 Thread Yann Jobic
Hello, I'm trying to understand how to use the lowlevel Petsc Finit Element Framework. I've got few questions about it. 1) I'm checking the determinant of the Jacobian transformation from real space to the parametric one. The source code is in :

Re: [petsc-users] MatSetValue in Fortran

2022-02-09 Thread Yann Jobic
there is no slot for 107 column. Barry On Feb 9, 2022, at 10:33 AM, Yann Jobic <mailto:yann.jo...@univ-amu.fr>> wrote: I'm struggling for a very simple error that i can not see. I'm running in a sequential program, for the test. MatView is giving me for the row 125 : row 125: (125, 0.)

Re: [petsc-users] MatSetValue in Fortran

2022-02-09 Thread Yann Jobic
ixf.c:582 I'm obviously doing something wrong, but where ? Thanks, Yann Le 2/9/2022 à 12:46 PM, Matthew Knepley a écrit : On Wed, Feb 9, 2022 at 5:56 AM Yann Jobic <mailto:yann.jo...@univ-amu.fr>> wrote: Dear All, I'm facing a strange problem. I did not succeed in putting s

Re: [petsc-users] Quasi newton SNES change variable

2022-02-09 Thread Yann Jobic
I'm struggling for a very simple error that i can not see. I'm running in a sequential program, for the test. MatView is giving me for the row 125 : row 125: (125, 0.) (107, 0.) I'm getting those values with MatGetRow : row=125 CALL

[petsc-users] MatSetValue in Fortran

2022-02-09 Thread Yann Jobic
Dear All, I'm facing a strange problem. I did not succeed in putting some values in an MPI matrix. I'm using Petsc 3.16.4. The matrix is pre-allocated, with some zeroes at the right position. To explain the context, it's a finit elements code, thus in the tangent matrix creation, i've got a

Re: [petsc-users] scotch compilation error on 14.2 with intel compiler

2020-12-03 Thread Yann Jobic
Le 12/3/2020 à 9:14 PM, Matthew Knepley a écrit : On Thu, Dec 3, 2020 at 3:10 PM Yann Jobic <mailto:yann.jo...@univ-amu.fr>> wrote: Hi all, I'm running on a surprising  compilation problem with petsc 14.1 and 14.2 on centos 7.9, with the intel compiler (17 and 18).

Re: [petsc-users] 1D parallel split of dense matrix

2020-09-17 Thread Yann Jobic
Hi Stefano, You're right, i just switched the rows and colomns, and it's working fine. However, i've done this in order to have better performance when i access the rows, with MatGetRow. With this order, i need MatGetColumnVector, which is believe is kind of slow, as stated in the comments

Re: [petsc-users] 1D parallel split of dense matrix

2020-09-17 Thread Yann Jobic
Hello Pierre, I just tested it, it's working just fine ! I thought i could have problems using mumps, as i rapidly read your article, and that i may be using MatMatSolve, but no, it's working. I have correct results. This interface for multi-RHS is indeed very handy. One question : I used

[petsc-users] 1D parallel split of dense matrix

2020-09-17 Thread Yann Jobic
Hi all, I want to decompose a matrix in parallel for only one direction, the columns, for a dense matrix, loaded from a binary file. I tried to use : MatCreateDense(PETSC_COMM_WORLD,NumberOfRhs,matLocNbCols,NumberOfRhs,matNbCols,NULL,); with matLocNbCols the number of local columns of a linear

Re: [petsc-users] node DG with DMPlex

2020-03-27 Thread Yann Jobic
Hi matt, Many thanks for the help !! Le 3/26/2020 à 11:38 PM, Matthew Knepley a écrit :         17              18   7-8-9-1415    |               |                | 16,3    4    5,6    11   12,13    |               |                |    1-2-3-9-10        

Re: [petsc-users] node DG with DMPlex

2020-03-26 Thread Yann Jobic
Hi matt Le 3/23/2020 à 2:24 PM, Matthew Knepley a écrit : On Wed, Mar 18, 2020 at 12:58 PM Yann Jobic <mailto:yann.jo...@univ-amu.fr>> wrote: Hi matt, Le 3/17/2020 à 4:00 PM, Matthew Knepley a écrit : > On Mon, Mar 16, 2020 at 5:20 PM Yann Jobic mailto:yann.jo...

Re: [petsc-users] node DG with DMPlex

2020-03-18 Thread Yann Jobic
Hi matt, Le 3/17/2020 à 4:00 PM, Matthew Knepley a écrit : On Mon, Mar 16, 2020 at 5:20 PM Yann Jobic <mailto:yann.jo...@univ-amu.fr>> wrote: Hi all, I would like to implement a nodal DG with the DMPlex interface. Therefore, i must add the internal nodes to the DM (

[petsc-users] node DG with DMPlex

2020-03-16 Thread Yann Jobic
Hi all, I would like to implement a nodal DG with the DMPlex interface. Therefore, i must add the internal nodes to the DM (GLL nodes), with the constrains : 1) Add them as solution points, with correct coordinates (and keep the good rotational ordering) 2) Find the shared nodes at faces in

Re: [petsc-users] cmake, pkg-config and Libs.private

2020-03-11 Thread Yann Jobic
tatic : " ${STATIC_LIBS}) And it works. Is it the right way to do it ? Thanks, Best regards, Yann Le 11/03/2020 à 11:59, Yann Jobic a écrit : Hi all, I'm trying to create a correct CMakeLists.txt in order to compile a petsc program. I can compile my code, but i cannot link it. I have

[petsc-users] cmake, pkg-config and Libs.private

2020-03-11 Thread Yann Jobic
Hi all, I'm trying to create a correct CMakeLists.txt in order to compile a petsc program. I can compile my code, but i cannot link it. I have this link command : /local/lib/openmpi/gcc8/4.0.3/bin/mpicc -g -rdynamic CMakeFiles/Test1.dir/src/dvm_dg1D_qff_2dV.c.o

Re: [petsc-users] dof of DMDA & DMPlex

2019-12-06 Thread Yann Jobic
. Was the email thread referring to spatial dimension? Yann Jobic writes: Hello, I read in the email archive (from 2016) that, at that time, the number of synchronized dof (in MPI/ghost cells sense) is 3 or 4. Is that still the case ? I would like to use PETSc for solving the Boltzmann equation (via

[petsc-users] dof of DMDA & DMPlex

2019-12-05 Thread Yann Jobic
Hello, I read in the email archive (from 2016) that, at that time, the number of synchronized dof (in MPI/ghost cells sense) is 3 or 4. Is that still the case ? I would like to use PETSc for solving the Boltzmann equation (via Discreet velocity method, which means a lot of dof per node). Is

Re: [petsc-users] SLEPc GEVP for huge systems

2019-11-20 Thread Yann Jobic via petsc-users
Hi Jose, My matrices were not correct... It's now running fine, with mumps. Thanks for the help, Best regards, Yann On 20/11/2019 15:22, Jose E. Roman wrote: El 19 nov 2019, a las 22:05, Yann Jobic escribió: Thanks for the fast answer ! The error coming from MUMPS is : On return from

Re: [petsc-users] SLEPc GEVP for huge systems

2019-11-19 Thread Yann Jobic via petsc-users
be competitive. Jose El 19 nov 2019, a las 17:06, Yann Jobic via petsc-users escribió: Hi all, I'm trying to solve a huge generalize (unsymetric) eigen value problem with SLEPc + MUMPS. We actually failed to allocate the requested memory for MUMPS factorization (we tried BVVECS). We would like

[petsc-users] SLEPc GEVP for huge systems

2019-11-19 Thread Yann Jobic via petsc-users
Hi all, I'm trying to solve a huge generalize (unsymetric) eigen value problem with SLEPc + MUMPS. We actually failed to allocate the requested memory for MUMPS factorization (we tried BVVECS). We would like to know if there is an alternate iterative way of solving such problems. Thank you,

[petsc-users] ghost nodes with a DMPlex

2019-01-16 Thread Yann Jobic via petsc-users
Hi, sorry if this is an obvious question, but i don't know how to use the ghost nodes with a DMPlex. The procedure i do is as follow : 1) create the DMPlex 2) distribute it 3) Create the Matrix and associated vectors with DMCreateMatrix, DMCreateGlobalVector and DMCreateLocalVector 4) In

Re: [petsc-users] DMPlex H27 elements

2019-01-10 Thread Yann Jobic via petsc-users
On 08/01/2019 19:45, Yann Jobic via petsc-users wrote: On 05/01/2019 13:23, Matthew Knepley wrote: On Sat, Jan 5, 2019 at 4:04 AM Yann Jobic <mailto:yann.jo...@univ-amu.fr>> wrote: On 05/01/2019 02:36, Matthew Knepley wrote: On Fri, Jan 4, 2019 at 10:04 AM Yann Jobic

Re: [petsc-users] basis functions of high order approximation (FE)

2019-01-08 Thread Yann Jobic via petsc-users
It's clear now ! Many thanks for the explanations. Yann On 08/01/2019 17:30, Jed Brown wrote: Yes, tensor product of Lagrange polynomials, often written as Q_k. Degrees of freedom associated with Dirichlet boundary conditions have been removed in the systems you're looking at. Yann Jobic via

Re: [petsc-users] DMPlex H27 elements

2019-01-08 Thread Yann Jobic via petsc-users
On 05/01/2019 13:23, Matthew Knepley wrote: On Sat, Jan 5, 2019 at 4:04 AM Yann Jobic <mailto:yann.jo...@univ-amu.fr>> wrote: On 05/01/2019 02:36, Matthew Knepley wrote: On Fri, Jan 4, 2019 at 10:04 AM Yann Jobic via petsc-users mailto:petsc-users@mcs.anl.go

[petsc-users] basis functions of high order approximation (FE)

2019-01-08 Thread Yann Jobic via petsc-users
Dear Petsc Users, I've been playing with the option "space_degree", in 2D, for a space discretisation of 4 cells (2x2), for a poisson problem, and i wonder what are the underlying concepts. With a space degree 2, i get a    9x9   algebraic system, and i've got a solution convergence order

Re: [petsc-users] DMPlex H27 elements

2019-01-07 Thread Yann Jobic via petsc-users
Le 05/01/2019 à 13:23, Matthew Knepley a écrit : On Sat, Jan 5, 2019 at 4:04 AM Yann Jobic <mailto:yann.jo...@univ-amu.fr>> wrote: On 05/01/2019 02:36, Matthew Knepley wrote: On Fri, Jan 4, 2019 at 10:04 AM Yann Jobic via petsc-users mailto:petsc-users@mcs.anl.go

Re: [petsc-users] DMPlex H27 elements

2019-01-05 Thread Yann Jobic via petsc-users
On 05/01/2019 02:36, Matthew Knepley wrote: On Fri, Jan 4, 2019 at 10:04 AM Yann Jobic via petsc-users mailto:petsc-users@mcs.anl.gov>> wrote: Dear Petsc Users, I'm using DMPlexCreateFromCellList to create my DM. I would like to have an order 2 geometry. It's w

[petsc-users] DMPlex H27 elements

2019-01-04 Thread Yann Jobic via petsc-users
Dear Petsc Users, I'm using DMPlexCreateFromCellList to create my DM. I would like to have an order 2 geometry. It's working fine in 2D for elements of type Q9. I checked that it's working correctly by using DMPlexComputeCellGeometryFEM, and compute the value of the determinant

Re: [petsc-users] interpolate HDF5 mesh

2018-12-20 Thread Yann Jobic via petsc-users
On 20/12/2018 21:33, Matthew Knepley wrote: On Thu, Dec 20, 2018 at 2:35 PM Yann JOBIC <mailto:yann.jo...@univ-amu.fr>> wrote: Le 20/12/2018 à 19:05, Matthew Knepley a écrit : On Thu, Dec 20, 2018 at 12:56 PM Yann JOBIC mailto:yann.jo...@univ-amu.fr>> wrote:

Re: [petsc-users] interpolate HDF5 mesh

2018-12-20 Thread Yann JOBIC via petsc-users
Le 20/12/2018 à 19:05, Matthew Knepley a écrit : On Thu, Dec 20, 2018 at 12:56 PM Yann JOBIC <mailto:yann.jo...@univ-amu.fr>> wrote: Le 20/12/2018 à 16:40, Matthew Knepley a écrit : On Thu, Dec 20, 2018 at 9:33 AM Yann JOBIC via petsc-users mailto:petsc-users@mcs.anl.go

Re: [petsc-users] interpolate HDF5 mesh

2018-12-20 Thread Yann JOBIC via petsc-users
Le 20/12/2018 à 16:40, Matthew Knepley a écrit : On Thu, Dec 20, 2018 at 9:33 AM Yann JOBIC via petsc-users mailto:petsc-users@mcs.anl.gov>> wrote: Dear Petsc Users, When i'm using DMPlexCreateBoxMesh, my code works fine. However, when i load the "exact" same m

[petsc-users] interpolate HDF5 mesh

2018-12-20 Thread Yann JOBIC via petsc-users
Dear Petsc Users, When i'm using DMPlexCreateBoxMesh, my code works fine. However, when i load the "exact" same mesh from an HDF5 file, it's not working anymore (Nonlinear solve did not converge due to DIVERGED_FNORM_NAN iterations 0). The mesh view when i use DMPlexCreateBoxMesh looks like

Re: [petsc-users] strange error by changing the number of cells.

2018-12-18 Thread Yann JOBIC via petsc-users
Le 18/12/2018 à 14:26, Matthew Knepley a écrit : On Tue, Dec 18, 2018 at 5:23 AM Yann JOBIC via petsc-users mailto:petsc-users@mcs.anl.gov>> wrote: Le 18/12/2018 à 03:01, Matthew Knepley a écrit : On Mon, Dec 17, 2018 at 4:24 PM Yann Jobic via petsc-users mailto:petsc

Re: [petsc-users] strange error by changing the number of cells.

2018-12-18 Thread Yann JOBIC via petsc-users
Le 18/12/2018 à 14:26, Matthew Knepley a écrit : On Tue, Dec 18, 2018 at 5:23 AM Yann JOBIC via petsc-users mailto:petsc-users@mcs.anl.gov>> wrote: Le 18/12/2018 à 03:01, Matthew Knepley a écrit : On Mon, Dec 17, 2018 at 4:24 PM Yann Jobic via petsc-users mailto:petsc

Re: [petsc-users] strange error by changing the number of cells.

2018-12-18 Thread Yann JOBIC via petsc-users
Le 18/12/2018 à 03:01, Matthew Knepley a écrit : On Mon, Dec 17, 2018 at 4:24 PM Yann Jobic via petsc-users mailto:petsc-users@mcs.anl.gov>> wrote: Dear petsc users, I'm using petsc FEM framework, with p4est. I'm getting a strange error, when changing the number of

Re: [petsc-users] strange error by changing the number of cells.

2018-12-17 Thread Yann Jobic via petsc-users
I'd like to add that it only occurs in parallel. Yann On 17/12/2018 22:24, Yann Jobic via petsc-users wrote: Dear petsc users, I'm using petsc FEM framework, with p4est. I'm getting a strange error, when changing the number of point in DMPlexCreateBoxMesh() (2D, 20x20 is ok, 22x22

[petsc-users] strange error by changing the number of cells.

2018-12-17 Thread Yann Jobic via petsc-users
Dear petsc users, I'm using petsc FEM framework, with p4est. I'm getting a strange error, when changing the number of point in DMPlexCreateBoxMesh() (2D, 20x20 is ok, 22x22 is not) : [0]PETSC ERROR: Nonconforming object sizes [0]PETSC ERROR: The section point closure size 20 != dual space

Re: [petsc-users] DMPlex, output value on gauss point to vertex

2018-10-23 Thread Yann Jobic
to do it with DMPlex? The PetscSF given by DMPlexDistribute has the info how mesh points are distributed. Can I create a mapping from it or it can be used to map mesh point in natural ordering to global ordering or the other way around? Thanks, Josh -- ___ Yann

Re: [petsc-users] DMPLEX project function error

2018-10-14 Thread yann JOBIC
Hi Ellen, I've made an old code (i forgot in which version it's working) that gives local coordinates and connectivity of a distributed DM. I didn't check that it's working again. I'll also work on that on the future. If it can help, i send you my ugly code (i didn't clean it). Yann On

Re: [petsc-users] DMForestTransferVec with -petscspace_order 0

2018-04-04 Thread Yann Jobic
Hi Isaac, It's working !! Many thanks ! Regards, Yann Le 04/04/2018 à 15:18, Tobin Isaac a écrit : Hi Yann, On Tue, Apr 03, 2018 at 05:29:39PM +0200, Yann Jobic wrote: Hi, Thanks for the fast answer ! And sorry for my late one... As a test, i'm using ex2.c in test/forest directory. I'm

Re: [petsc-users] DMForestTransferVec with -petscspace_order 0

2018-04-03 Thread Yann Jobic
, Toby On Mon, Apr 02, 2018 at 04:42:29PM +0200, yann JOBIC wrote: Hi, I'm using DMForestTransferVec, as in "dm/impls/forest/examples/tests/ex2.c". I would like to use it with a space approximation order at zero (-petscspace_order 0). However, in this case, it's not working (valgr

[petsc-users] DMForestTransferVec with -petscspace_order 0

2018-04-02 Thread yann JOBIC
Hi, I'm using DMForestTransferVec, as in "dm/impls/forest/examples/tests/ex2.c". I would like to use it with a space approximation order at zero (-petscspace_order 0). However, in this case, it's not working (valgrind output of ex2.c from forest test) : ==8604== Conditional jump or move

Re: [petsc-users] FEM & conformal mesh

2018-02-15 Thread Yann Jobic
Hello Matt, Le 15/02/2018 à 00:41, Matthew Knepley a écrit : On Tue, Jan 23, 2018 at 11:14 AM, Yann Jobic <yann.jo...@univ-amu.fr <mailto:yann.jo...@univ-amu.fr>> wrote: Hello, I'm trying to understand the numbering of quadrature points in order to solve the FEM sys

[petsc-users] FEM & conformal mesh

2018-01-23 Thread Yann Jobic
Hello, I'm trying to understand the numbering of quadrature points in order to solve the FEM system, and how you manage this numbering in order to allow conformal mesh. I looked in several files in order to understand. Here's what i understood so far (which is not far...) I took the example

Re: [petsc-users] local to global mapping for DMPlex

2017-12-20 Thread Yann JOBIC
On 12/19/2017 05:50 PM, Matthew Knepley wrote: On Tue, Dec 19, 2017 at 11:40 AM, Yann JOBIC <yann.jo...@univ-amu.fr <mailto:yann.jo...@univ-amu.fr>> wrote: Hello, We want to extract the cell connectivity from a DMPlex. We have no problem for a sequential run.

[petsc-users] local to global mapping for DMPlex

2017-12-19 Thread Yann JOBIC
Hello, We want to extract the cell connectivity from a DMPlex. We have no problem for a sequential run. However for parallel ones, we need to get the node numbering in the global ordering, as when we distribute the mesh, we only have local nodes, and thus local numbering. It seems that we

Re: [petsc-users] Boundary condition IS

2017-12-06 Thread Yann Jobic
Le 07/12/2017 à 08:23, Mohammad Hassan Baghaei a écrit : Hello I am using DMPlex to construct a fully circular 2D domain for my PDEs. As I am discretizing the PDEs using finite difference method, I need to know , to define the layout of PetscSection, how I can find the boundary condition

Re: [petsc-users] 2 Dirichlet conditions for one Element in PetscFE

2017-12-05 Thread Yann Jobic
Hello, I tried the master of the git directory, as you have merged the branch. It works ! Many thanks for the fix. Best regards, Yann Le 22/11/2017 à 18:51, Matthew Knepley a écrit : On Wed, Nov 22, 2017 at 12:39 PM, Yann Jobic <yann.jo...@univ-amu.fr <mailto:yann.jo...@univ-amu.fr&g

Re: [petsc-users] 2 Dirichlet conditions for one Element in PetscFE

2017-11-24 Thread Yann Jobic
iple where the possible bug should be. I now use a simple Poisson FE test case in order to check the boundaries. I hope these details helps a little... Regards, Yann Le 24/11/2017 à 11:34, Yann Jobic a écrit : Le 23/11/2017 à 13:45, Matthew Knepley a écrit : On Thu, Nov 23, 2017 at 3:39 AM,

Re: [petsc-users] 2 Dirichlet conditions for one Element in PetscFE

2017-11-24 Thread Yann Jobic
Le 23/11/2017 à 13:45, Matthew Knepley a écrit : On Thu, Nov 23, 2017 at 3:39 AM, Yann Jobic <yann.jo...@univ-amu.fr <mailto:yann.jo...@univ-amu.fr>> wrote: Hello, I checked out  the branch knepley/fix-plex-bc-multiple, but i now have a strange problem. I split

Re: [petsc-users] 2 Dirichlet conditions for one Element in PetscFE

2017-11-23 Thread Yann Jobic
Hello, Le 23/11/2017 à 13:45, Matthew Knepley a écrit : On Thu, Nov 23, 2017 at 3:39 AM, Yann Jobic <yann.jo...@univ-amu.fr <mailto:yann.jo...@univ-amu.fr>> wrote: Hello, I checked out  the branch knepley/fix-plex-bc-multiple, but i now have a strange problem.

Re: [petsc-users] 2 Dirichlet conditions for one Element in PetscFE

2017-11-23 Thread Yann Jobic
On Wed, Nov 22, 2017 at 12:39 PM, Yann Jobic <yann.jo...@univ-amu.fr <mailto:yann.jo...@univ-amu.fr>> wrote: Hello, I've found a strange behavior when looking into a bug for the pressure convergence of a simple Navier-Stokes problem using PetscFE. I followed many example

[petsc-users] 2 Dirichlet conditions for one Element in PetscFE

2017-11-22 Thread Yann Jobic
Hello, I've found a strange behavior when looking into a bug for the pressure convergence of a simple Navier-Stokes problem using PetscFE. I followed many examples for labeling boundary faces. I first use DMPlexMarkBoundaryFaces, (label=1 to the faces). I find those faces using

Re: [petsc-users] DMPlexCreateFromDAG and orientation

2017-11-20 Thread Yann Jobic
Hi, Finally i used DMPlexCreateFromCellList, i don't know why i didn't try it first. I indeed create hex cells (so far). And it works ! Thanks for the help, Yann Le 20/11/2017 à 14:47, Matthew Knepley a écrit : On Sun, Nov 19, 2017 at 4:59 PM, Yann Jobic <yann.jo...@univ-amu

[petsc-users] DMPlexCreateFromDAG and orientation

2017-11-19 Thread Yann Jobic
Hello, I want to create my custom DMPLEX by using DMPlexCreateFromDAG(). I tried with only one cell. I have :   type: plex Mesh 'DM_0x3dd7df0_0': orientation is missing cap --> base: [0] Max sizes cone: 8 support: 1 [0]: 1 > 0 [0]: 2 > 0 [0]: 3 > 0 [0]: 4 > 0 [0]: 5 > 0

Re: [petsc-users] DMPlexVecGetClosure for DM forest

2017-11-10 Thread Yann JOBIC
On 11/09/2017 07:22 PM, Matthew Knepley wrote: On Thu, Nov 9, 2017 at 1:20 PM, Yann Jobic <yann.jo...@univ-amu.fr <mailto:yann.jo...@univ-amu.fr>> wrote: Hello, I'm trying to access to the values of a p4est forest. I know how to do that by converting my forest

[petsc-users] DMPlexVecGetClosure for DM forest

2017-11-09 Thread Yann Jobic
Hello, I'm trying to access to the values of a p4est forest. I know how to do that by converting my forest to a DMPlex, and then use DMPlexVecGetClosure over the converted DM. However, i want to assign a label and access to the values of the forest directly. Is it possible ? Thanks, Yann ---

[petsc-users] multi level octree AMR

2017-11-09 Thread Yann JOBIC
Hi, I succeed in having a basic AMR running on my FE advection/diffusion problem ( https://mycore.core-cloud.net/index.php/s/DmiiTwKUpV9z5qL) I now want to have multiple levels in my octree AMR from p4est. I tried a lot with IS tagged arrays, but i didn't succeed so far. When i get from

Re: [petsc-users] DMPlex with AMR

2017-11-05 Thread Yann Jobic
Thanks for the fast answer ! Le 05/11/2017 à 20:06, Matthew Knepley a écrit : On Sun, Nov 5, 2017 at 2:04 PM, Matthew Knepley <knep...@gmail.com <mailto:knep...@gmail.com>> wrote: On Sun, Nov 5, 2017 at 1:45 PM, Yann Jobic <yann.jo...@univ-amu.fr <mailto:yann.jo...@u

[petsc-users] DMPlex with AMR

2017-11-05 Thread Yann Jobic
Dear PETSc expert, I first correctly solve the advection/diffusion equation, with the advection/diffusion of a gaussian, in a rotate field. I'm using finit element, with PetscFE and the velocity field is in an auxillary one, in order to correctly set the residual and the jacobian. Then, i