[petsc-users] Questions DMPlex

2024-09-30 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
Hi, We have been using PETSc’s block version of the AIJ matrix format to implement fully coupled multiphysics problems using finite elements. Are there specific advantages to moving toward DMPlex for finite element-based coupled multi-physics implementation? Can you still access Hypre? Does the

[petsc-users] Error: PCHYPRESetPoissonMatrix_HYPRE

2024-09-19 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
Hello, I would like to make the following hypre call HYPRE_AMSSetBetaPoissonMatrix(ams, NULL); So it does look like ams_beta_is_zero has to be true https://urldefense.us/v3/__https://gitlab.com/petsc/petsc/-/blob/main/src/ksp/pc/impls/hypre/hypre.c?ref_type=heads*L325__;Iw!!G_uCfscf7eWS!bi4rdSrr

Re: [petsc-users] Hypre AMS usage

2024-09-09 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
petscErr = PCHYPRESetDiscreteGradient(pc, par_G); // Set vertex coordinates petscErr = PCHYPRESetEdgeConstantVectors(pc, par_xvec, par_yvec, par_zvec); From: Matthew Knepley Date: Monday, 9 September 2024 at 21:11 To: Chockalingam, Karthikeyan (STFC,DL,HC) Cc: Stefano Zampini , petsc-users@

Re: [petsc-users] Hypre AMS usage

2024-09-09 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
,HC) Cc: Stefano Zampini , petsc-users@mcs.anl.gov Subject: Re: [petsc-users] Hypre AMS usage On Mon, Sep 9, 2024 at 3:38 PM Karthikeyan Chockalingam - STFC UKRI mailto:karthikeyan.chockalin...@stfc.ac.uk>> wrote: I didn’t know how to check the pc type but adding petscErr = PCSetType(pc,

Re: [petsc-users] Hypre AMS usage

2024-09-09 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
ate: Monday, 9 September 2024 at 19:46 To: Chockalingam, Karthikeyan (STFC,DL,HC) Cc: Stefano Zampini , petsc-users@mcs.anl.gov Subject: Re: [petsc-users] Hypre AMS usage On Mon, Sep 9, 2024 at 2:18 PM Karthikeyan Chockalingam - STFC UKRI mailto:karthikeyan.chockalin...@stfc.ac.uk>> wrote: Calli

Re: [petsc-users] Hypre AMS usage

2024-09-09 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
Zampini , petsc-users@mcs.anl.gov Subject: Re: [petsc-users] Hypre AMS usage On Mon, Sep 9, 2024 at 1:21 PM Karthikeyan Chockalingam - STFC UKRI mailto:karthikeyan.chockalin...@stfc.ac.uk>> wrote: Hi Stefano, Thank you. That was helpful. I tried the following: petscErr = PetscOptionsSe

Re: [petsc-users] Hypre AMS usage

2024-09-09 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
n (STFC,DL,HC) mailto:karthikeyan.chockalin...@stfc.ac.uk>> Cc: petsc-users@mcs.anl.gov<mailto:petsc-users@mcs.anl.gov> mailto:petsc-users@mcs.anl.gov>> Subject: Re: [petsc-users] Hypre AMS usage On Fri, Sep 6, 2024 at 11:37 AM Karthikeyan Chockalingam - STFC UKRI via petsc-user

Re: [petsc-users] Hypre AMS usage

2024-09-09 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
:37 AM Karthikeyan Chockalingam - STFC UKRI via petsc-users mailto:petsc-users@mcs.anl.gov>> wrote: Hello, I am trying to use the Hypre AMS preconditioner for the first time. I am following the example problem from Hypre https://urldefense.us/v3/__https://github.com/hypre-spac

[petsc-users] Hypre AMS usage

2024-09-06 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
Hello, I am trying to use the Hypre AMS preconditioner for the first time. I am following the example problem from Hypre https://urldefense.us/v3/__https://github.com/hypre-space/hypre/blob/3caa81955eb8d1b4e35d9b450e27cf6d07b50f6e/src/examples/ex15.c*L954__;Iw!!G_uCfscf7eWS!biuCOXkV-qD-e8iTXiwaD9

Re: [petsc-users] MPIAIJ MatMult and non conforming object sizes

2024-09-05 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
properly for both x and y in y = Ax when A is not square. On Sep 5, 2024, at 5:20 PM, Karthikeyan Chockalingam - STFC UKRI via petsc-users wrote: Hello, I am unsure why the program crashes even while running the code serially petscErr = MatCreate(mesh.comm().get(), &par_G); pets

[petsc-users] MPIAIJ MatMult and non conforming object sizes

2024-09-05 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
Hello, I am unsure why the program crashes even while running the code serially petscErr = MatCreate(mesh.comm().get(), &par_G); petscErr = MatSetType(par_G, MATMPIAIJ); petscErr = MatSetSizes(par_G, local_num_rows, local_num_cols, total_num_rows, total_num_cols); PetscInt d_nz = 2;

[petsc-users] PETSc-GPU

2024-04-26 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
Hello, When PETSc is installed with GPU support, will it run only on GPUs or can it be run on CPUs (without GPUs)? Currently, PETSc crashes when run on CPUs. Thank you. Best regards, Karthik. -- Karthik Chockalingam, Ph.D. Senior Research Software Engineer High Performance Systems Engineering

Re: [petsc-users] Coupled system of equations on unstructured mesh

2023-09-23 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
-users] Coupled system of equations on unstructured mesh On Sat, Sep 23, 2023 at 6:00 AM Karthikeyan Chockalingam - STFC UKRI mailto:karthikeyan.chockalin...@stfc.ac.uk>> wrote: I just would like to clarify a couple of things. 1)The M and N, in MatCreateBIJ, refer to the actual number of globa

Re: [petsc-users] Coupled system of equations on unstructured mesh

2023-09-23 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
Sun, Sep 10, 2023 at 5:00 PM Karthikeyan Chockalingam - STFC UKRI mailto:karthikeyan.chockalin...@stfc.ac.uk>> wrote: I get it. Q1) In other words when using MatSetValuesBlocked, for bs = 2, I could pass all 64 entrees of the element matrix row-oriented by setting m = n = 4 (along wit

Re: [petsc-users] Coupled system of equations on unstructured mesh

2023-09-10 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
Karthikeyan Chockalingam - STFC UKRI mailto:karthikeyan.chockalin...@stfc.ac.uk>> wrote: I don’t see an option to give block size. https://petsc.org/release/manualpages/Mat/MatCreateAIJ/ https://petsc.org/release/manualpages/Mat/MatSetBlockSize/ Thanks, Matt Many thanks, Karthik.

Re: [petsc-users] Coupled system of equations on unstructured mesh

2023-09-10 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
system of equations on unstructured mesh On Sun, Sep 10, 2023 at 3:01 PM Karthikeyan Chockalingam - STFC UKRI mailto:karthikeyan.chockalin...@stfc.ac.uk>> wrote: I will solve the coupled problem in a non-linear fashion using SNES, so I will have one residual for each variable R(u1) and R(u2) a

Re: [petsc-users] Coupled system of equations on unstructured mesh

2023-09-10 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
gards, Karthik. From: Matthew Knepley Date: Sunday, 10 September 2023 at 19:03 To: Chockalingam, Karthikeyan (STFC,DL,HC) Cc: petsc-users@mcs.anl.gov Subject: Re: [petsc-users] Coupled system of equations on unstructured mesh On Sun, Sep 10, 2023 at 1:48 PM Karthikeyan Chockalingam - STFC UKRI via

[petsc-users] Coupled system of equations on unstructured mesh

2023-09-10 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
Hello, I have so far solved scalar field problems using finite elements on a given (unstructured) mesh. I made use of MATMPIAIJ to create matrixes, MatCreateVecs(A, &b, &x) to create vectors, and MatZeroRowsColumnsIS to set boundary conditions. Now, I would like to solve a coupled system of eq

Re: [petsc-users] Non-linear solve: DIVERGED_LINE_SEARCH

2023-09-07 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
. From: Matthew Knepley Date: Thursday, 7 September 2023 at 14:32 To: Chockalingam, Karthikeyan (STFC,DL,HC) Cc: Stefano Zampini , petsc-users@mcs.anl.gov Subject: Re: [petsc-users] Non-linear solve: DIVERGED_LINE_SEARCH On Thu, Sep 7, 2023 at 9:28 AM Karthikeyan Chockalingam - STFC UKRI

Re: [petsc-users] Non-linear solve: DIVERGED_LINE_SEARCH

2023-09-07 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
Zampini , petsc-users@mcs.anl.gov Subject: Re: [petsc-users] Non-linear solve: DIVERGED_LINE_SEARCH On Thu, Sep 7, 2023 at 8:49 AM Karthikeyan Chockalingam - STFC UKRI via petsc-users mailto:petsc-users@mcs.anl.gov>> wrote: I just noticed that the line search diverges even for the linear P

Re: [petsc-users] Non-linear solve: DIVERGED_LINE_SEARCH

2023-09-07 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
accuracy do you want? Il giorno gio 7 set 2023 alle ore 13:08 Karthikeyan Chockalingam - STFC UKRI via petsc-users mailto:petsc-users@mcs.anl.gov>> ha scritto: Hello, The non-linear solution diverged. The final solution seems right and I believe the Jacobian is correct (not 100% certain). I

Re: [petsc-users] Non-linear solve: DIVERGED_LINE_SEARCH

2023-09-07 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
Chockalingam - STFC UKRI via petsc-users mailto:petsc-users@mcs.anl.gov>> ha scritto: Hello, The non-linear solution diverged. The final solution seems right and I believe the Jacobian is correct (not 100% certain). I am not sure if I doing something wrong in the solver setting. 0 SNES Functio

[petsc-users] Non-linear solve: DIVERGED_LINE_SEARCH

2023-09-07 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
Hello, The non-linear solution diverged. The final solution seems right and I believe the Jacobian is correct (not 100% certain). I am not sure if I doing something wrong in the solver setting. 0 SNES Function norm 3.890991210938e-03 0 KSP Residual norm 9.037762538598e+00 1 KSP Res

Re: [petsc-users] periodic boundary conditions

2023-07-19 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
exist. On Jul 18, 2023, at 12:03 PM, Karthikeyan Chockalingam - STFC UKRI mailto:karthikeyan.chockalin...@stfc.ac.uk>> wrote: Thank you, Barry. I am using the MPIAIJ format for a Finite Element application. So, I am trying to understand what is implemented in DMDA to eliminate th

Re: [petsc-users] periodic boundary conditions

2023-07-18 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
nate extra ones On Jul 18, 2023, at 11:51 AM, Karthikeyan Chockalingam - STFC UKRI via petsc-users wrote: Yes, I clearly understand I need to eliminate one set of periodic nodes. I was hoping to use x = P x’ to eliminate one set. It is a kind of mapping. Sorry, I am not sure if it is the Loc

Re: [petsc-users] periodic boundary conditions

2023-07-18 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
-users@mcs.anl.gov<mailto:petsc-users@mcs.anl.gov> mailto:petsc-users@mcs.anl.gov>> Subject: Re: [petsc-users] periodic boundary conditions On Tue, Jul 18, 2023 at 9:02 AM Karthikeyan Chockalingam - STFC UKRI via petsc-users mailto:petsc-users@mcs.anl.gov>> wrote: Hello, This i

Re: [petsc-users] periodic boundary conditions

2023-07-18 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
: [petsc-users] periodic boundary conditions On Tue, Jul 18, 2023 at 9:02 AM Karthikeyan Chockalingam - STFC UKRI via petsc-users mailto:petsc-users@mcs.anl.gov>> wrote: Hello, This is exactly not a PETSc question. I am solving a Poisson equation using finite elements. I would like to impose

[petsc-users] periodic boundary conditions

2023-07-18 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
Hello, This is exactly not a PETSc question. I am solving a Poisson equation using finite elements. I would like to impose PBC. I am thinking of using the Lagrange multiplier method to impose them as constraints. Or do you think I could take an alternative approach? Thank you for your help. K

[petsc-users] Parallel matrix multiplication

2023-07-17 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
Hello, I would like to perform the following operation [P^T A P] x’ = P^T f Where P is a rectangular matrix and A is a square matrix. All the matrixes are constructed using MPIAIJ. Should I be concerned about the parallel partitioning of the matrix P and A? Or can I just go ahead and use Mat

Re: [petsc-users] Node numbering in parallel partitioned mesh

2023-05-02 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
users@mcs.anl.gov Subject: Re: [petsc-users] Node numbering in parallel partitioned mesh On Tue, May 2, 2023 at 8:25 AM Karthikeyan Chockalingam - STFC UKRI via petsc-users mailto:petsc-users@mcs.anl.gov>> wrote: Hello, This is not exactly a PETSc question. I have a parallel partitioned fini

[petsc-users] Node numbering in parallel partitioned mesh

2023-05-02 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
Hello, This is not exactly a PETSc question. I have a parallel partitioned finite element mesh. What are the steps involved in having a contiguous but unique set of node numbering from one partition to the next? There are nodes which are shared between different partitions. Moreover, this parti

Re: [petsc-users] Setting up a matrix for Lagrange multiplier

2023-04-24 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
: [petsc-users] Setting up a matrix for Lagrange multiplier On Mon, Apr 24, 2023 at 1:37 PM Karthikeyan Chockalingam - STFC UKRI mailto:karthikeyan.chockalin...@stfc.ac.uk>> wrote: Great to know there is an example now. Yes, -pc_fieldsplit_defect_saddle_point worked. But I would like to unde

Re: [petsc-users] Setting up a matrix for Lagrange multiplier

2023-04-24 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
k. From: Matthew Knepley Date: Monday, 24 April 2023 at 17:57 To: Chockalingam, Karthikeyan (STFC,DL,HC) Cc: petsc-users@mcs.anl.gov Subject: Re: [petsc-users] Setting up a matrix for Lagrange multiplier On Mon, Apr 24, 2023 at 10:22 AM Karthikeyan Chockalingam - STFC UKRI mailto:karthikeyan.chockalin.

Re: [petsc-users] Setting up a matrix for Lagrange multiplier

2023-04-24 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
ue, Apr 18, 2023 at 5:24 AM Karthikeyan Chockalingam - STFC UKRI via petsc-users mailto:petsc-users@mcs.anl.gov>> wrote: Hello, I'm solving a problem using the Lagrange multiplier, the matrix has the form K = [A P^T P 0] I am familiar with constructing K using MATMPIAIJ. However, I wou

Re: [petsc-users] question about MatSetLocalToGlobalMapping

2023-04-21 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
From: petsc-users on behalf of Matthew Knepley Sent: Thursday, April 20, 2023 5:37 AM To: Karthikeyan Chockalingam - STFC UKRI Cc: petsc-users@mcs.anl.gov Subject: Re: [petsc-users] question about MatSetLocalToGlobalMapping On Thu, Apr 20, 2023 at 6:13 AM Karthikeyan Chockalingam - STFC UKRI

Re: [petsc-users] question about MatSetLocalToGlobalMapping

2023-04-21 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
col_mapping); for (i=0; i Date: Thursday, 20 April 2023 at 11:37 To: Chockalingam, Karthikeyan (STFC,DL,HC) Cc: petsc-users@mcs.anl.gov Subject: Re: [petsc-users] question about MatSetLocalToGlobalMapping On Thu, Apr 20, 2023 at 6:13 AM Karthikeyan Chockalingam - STFC UKRI via petsc-users

[petsc-users] question about MatSetLocalToGlobalMapping

2023-04-20 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
Hello, I created a new thread, thought would it be more appropriate (and is a continuation of my previous post). I want to construct the below K matrix (which is composed of submatrices) K = [A P^T P 0] Where K is of type MatMPIAIJ. I first constructed the top left [A] using MatSetVa

Re: [petsc-users] Setting up a matrix for Lagrange multiplier

2023-04-19 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
eyan Chockalingam - STFC UKRI mailto:karthikeyan.chockalin...@stfc.ac.uk>> wrote: Thank you for your response. I spend some time understanding how MatSetValuesLocal and ISLocalToGlobalMappingCreate work. You can look at SNES ex28 where we do this with DMCOMPOSITE. Q1) Will the matrix K

Re: [petsc-users] Setting up a matrix for Lagrange multiplier

2023-04-18 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
: Matthew Knepley Date: Tuesday, 18 April 2023 at 11:08 To: Chockalingam, Karthikeyan (STFC,DL,HC) Cc: petsc-users@mcs.anl.gov Subject: Re: [petsc-users] Setting up a matrix for Lagrange multiplier On Tue, Apr 18, 2023 at 5:24 AM Karthikeyan Chockalingam - STFC UKRI via petsc-users mailto:petsc-users

[petsc-users] Setting up a matrix for Lagrange multiplier

2023-04-18 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
Hello, I'm solving a problem using the Lagrange multiplier, the matrix has the form K = [A P^T P 0] I am familiar with constructing K using MATMPIAIJ. However, I would like to know if had [A], can I augment it with [P], [P^T] and [0] of type MATMPIAIJ? Likewise for vectors as well. C

[petsc-users] non-homogenous Dirichlet bc using MatZeroRowsColumns

2023-04-13 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
Hi, I am trying to solve the below parabolic system for a constant time interval dt (M + dt * K) x = M * x^(old) Where, M – Mass matrix K – Stiffness matrix A = M + dt * K (remains constant) I apply the boundary condition using MatZeroRowsColumns. For homogenous boundary conditions, I notice

Re: [petsc-users] Eliminating rows and columns which are zeros

2023-02-08 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
ierr = PetscOptionsSetValue(NULL,"-redistribute_pc_hypre_type", "boomeramg"); Many thanks, Karthik. From: Barry Smith Date: Tuesday, 7 February 2023 at 19:52 To: Chockalingam, Karthikeyan (STFC,DL,HC) Cc: petsc-users@mcs.anl.gov Subject: Re: [petsc-users] Eliminating rows

Re: [petsc-users] Eliminating rows and columns which are zeros

2023-02-06 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
! Karthik. From: Matthew Knepley Date: Monday, 6 February 2023 at 21:52 To: Chockalingam, Karthikeyan (STFC,DL,HC) Cc: Barry Smith , petsc-users@mcs.anl.gov Subject: Re: [petsc-users] Eliminating rows and columns which are zeros On Mon, Feb 6, 2023 at 4:45 PM Karthikeyan Chockalingam - STFC UKRI

Re: [petsc-users] Eliminating rows and columns which are zeros

2023-02-06 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
. Barry On Feb 4, 2023, at 12:06 PM, Karthikeyan Chockalingam - STFC UKRI wrote: Thank you very much for offering to debug. I built PETSc along with AMReX, so I tried to extract the PETSc code alone which would reproduce the same error on the smallest sized problem possible. I have atta

Re: [petsc-users] Eliminating rows and columns which are zeros

2023-02-04 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
problem with a simple code I can debug the problem and fix it. Barry On Feb 3, 2023, at 6:42 PM, Karthikeyan Chockalingam - STFC UKRI wrote: I updated the main branch to the below commit but the same problem persists. [0]PETSC ERROR: Petsc Development GIT revision: v3.18.4-529-g995ec06f92 GIT

Re: [petsc-users] Eliminating rows and columns which are zeros

2023-02-03 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
required that a row exist before we zeroed it but now we allow the row to initially have no entries and still be zeroed. Barry On Feb 3, 2023, at 1:04 PM, Karthikeyan Chockalingam - STFC UKRI wrote: Thank you. The entire error output was an attachment in my previous email. I am pasting here for

Re: [petsc-users] Eliminating rows and columns which are zeros

2023-02-03 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
@mcs.anl.gov Subject: Re: [petsc-users] Eliminating rows and columns which are zeros On Fri, Feb 3, 2023 at 1:05 PM Karthikeyan Chockalingam - STFC UKRI via petsc-users mailto:petsc-users@mcs.anl.gov>> wrote: Thank you. The entire error output was an attachment in my previous email. I am pasting he

Re: [petsc-users] Eliminating rows and columns which are zeros

2023-02-03 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
, 2023, at 11:41 AM, Karthikeyan Chockalingam - STFC UKRI wrote: Hello Barry, I would like to better understand pc_type redistribute usage. I am plan to use pc_type redistribute in the context of adaptive mesh refinement on a structured grid in 2D. My base mesh (level 0) is indexed from 0 to N

Re: [petsc-users] Eliminating rows and columns which are zeros

2023-02-03 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
contain correct values for ALL the locations including the (zeroed out rows). You use case is exactly what redistribute it for. Barry On Jan 10, 2023, at 11:25 AM, Karthikeyan Chockalingam - STFC UKRI wrote: Thank you Barry. This is great! I plan to solve using ‘-pc_type redistribute’ after

Re: [petsc-users] Eliminating rows and columns which are zeros

2023-01-10 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
-pc_type redistribute It does everything for you. Note that if the right hand side for any of the "zero" rows is nonzero then the system is inconsistent and the system does not have a solution. Barry On Jan 10, 2023, at 10:30 AM, Karthikeyan Chockalingam - STFC UKRI via p

[petsc-users] Eliminating rows and columns which are zeros

2023-01-10 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
Hello, I am assembling a MATIJ of size N, where a very large number of rows (and corresponding columns), are zeros. I would like to potentially eliminate them before the solve. For instance say N=7 0 0 0 0 0 0 0 0 1 -1 0 0 0 0 0 -1 2 0 0 0 -1 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0

Re: [petsc-users] Union of sequential vecs

2022-12-12 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
l index of the nonzero for each nonzero in Q, i=0:n. Do some sort of vec-scatter-to-all with R to get what you want. Does that work? Mark On Fri, Dec 9, 2022 at 3:25 PM Karthikeyan Chockalingam - STFC UKRI via petsc-users mailto:petsc-users@mcs.anl.gov>> wrote: That is where I am stu

Re: [petsc-users] Union of sequential vecs

2022-12-09 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
e n, then set R[i] = global index of the nonzero for each nonzero in Q, i=0:n. Do some sort of vec-scatter-to-all with R to get what you want. Does that work? Mark On Fri, Dec 9, 2022 at 3:25 PM Karthikeyan Chockalingam - STFC UKRI via petsc-users mailto:petsc-users@mcs.anl.gov>> wrote: T

Re: [petsc-users] Union of sequential vecs

2022-12-09 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
, 2022, at 2:28 PM, Karthikeyan Chockalingam - STFC UKRI via petsc-users wrote: Hi, I want to take the union of a set of sequential vectors, each living in a different processor. Say, Vec_Seq1 = {2,5,7} Vec_Seq2 = {5,8,10,11} Vec_Seq3 = {5,2,12}. Finally, get the union of all them Vec

[petsc-users] Union of sequential vecs

2022-12-09 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
Hi, I want to take the union of a set of sequential vectors, each living in a different processor. Say, Vec_Seq1 = {2,5,7} Vec_Seq2 = {5,8,10,11} Vec_Seq3 = {5,2,12}. Finally, get the union of all them Vec = {2,5,7,8,10,11,12}. I initially wanted to create a parallel vector and insert the (seq

[petsc-users] Using MatCreateSBAIJ and MatZeroRowsColumns in parallel

2022-12-02 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
Hello, I have system matrix which is symmetric and thought I could make use of MatCreateSBAIJ. I don’t understand how to set the blocksize bs. I believe it has taken into account, when having multiple components/dofs per node. (i) Currently, I have only one scalar field to solve so

Re: [petsc-users] Different solution while running in parallel

2022-11-28 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
ation of block Jacobi, so these results look fine to me, at least up to this point. Mark On Thu, Nov 17, 2022 at 9:37 AM Karthikeyan Chockalingam - STFC UKRI via petsc-users mailto:petsc-users@mcs.anl.gov>> wrote: Hi Matt and Hong, Thank you for your response. I made the following changes

Re: [petsc-users] PetscOptionsSetValue syntax

2022-11-18 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
Thank you. It worked! Best, Karthik. From: Pierre Jolivet Date: Friday, 18 November 2022 at 13:56 To: Chockalingam, Karthikeyan (STFC,DL,HC) Cc: petsc-users@mcs.anl.gov Subject: Re: [petsc-users] PetscOptionsSetValue syntax On 18 Nov 2022, at 2:47 PM, Karthikeyan Chockalingam - STFC UKRI

Re: [petsc-users] PetscOptionsSetValue syntax

2022-11-18 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
: Pierre Jolivet Date: Friday, 18 November 2022 at 13:36 To: Chockalingam, Karthikeyan (STFC,DL,HC) Cc: petsc-users@mcs.anl.gov Subject: Re: [petsc-users] PetscOptionsSetValue syntax On 18 Nov 2022, at 2:32 PM, Karthikeyan Chockalingam - STFC UKRI via petsc-users wrote:  Hello, I would like

[petsc-users] PetscOptionsSetValue syntax

2022-11-18 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
Hello, I would like to move from code to using options. KSP ksp; PCpc; KSPCreate(PETSC_COMM_WORLD, &ksp); KSPSetOperators(ksp, A, A); I tried using PetscOptionsSetValue as below ierr = PetscOptionsSetValue(NULL,"-ksp_type", "cg"); CHKERRQ(ierr); ie

Re: [petsc-users] Different solution while running in parallel

2022-11-17 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
DL,HC) Cc: Zhang, Hong , petsc-users@mcs.anl.gov Subject: Re: [petsc-users] Different solution while running in parallel On Thu, Nov 17, 2022 at 11:13 AM Karthikeyan Chockalingam - STFC UKRI mailto:karthikeyan.chockalin...@stfc.ac.uk>> wrote: Hi Matt, I tested two sizes manually for the Po

Re: [petsc-users] Different solution while running in parallel

2022-11-17 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
consistent RHS. Thanks, Matt On Thu, Nov 17, 2022 at 9:37 AM Karthikeyan Chockalingam - STFC UKRI mailto:karthikeyan.chockalin...@stfc.ac.uk>> wrote: Hi Matt and Hong, Thank you for your response. I made the following changes, to get the desired output PetscReal norm; /* n

Re: [petsc-users] Different solution while running in parallel

2022-11-17 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
users@mcs.anl.gov>> wrote: Karhik, Can you find out the condition number of your matrix? Also, run using -ksp_view -ksp_monitor_true_residual -ksp_converged_reason and send the two outputs. Thanks, Matt Hong From: petsc-users mailto:petsc-users-b

Re: [petsc-users] Different solution while running in parallel

2022-11-17 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
Also, run using -ksp_view -ksp_monitor_true_residual -ksp_converged_reason and send the two outputs. Thanks, Matt Hong From: petsc-users mailto:petsc-users-boun...@mcs.anl.gov>> on behalf of Karthikeyan Chockalingam - STFC UKRI via petsc-use

[petsc-users] Different solution while running in parallel

2022-11-16 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
Hello, I tried to solve a (FE discretized) Poisson equation using PCLU. For some reason I am getting different solutions while running the problem on one and two cores. I have attached the output file (out.txt) from both the runs. I am printing A, b and x from both the runs – while A and

[petsc-users] NVIDIA's AmgX library

2022-01-25 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
Hello, Is there a way one can use AmgX multigrid via PETSc? Kind regards, Karthik. This email and any attachments are intended solely for the use of the named recipients. If you are not the intended recipient you must not use, disclose, copy or distribute this email or any of its attachments a

Re: [petsc-users] Unstructured mesh

2021-12-15 Thread Karthikeyan Chockalingam - STFC UKRI via petsc-users
t this point. Mark Mark On Tue, Dec 14, 2021 at 2:42 AM Karthikeyan Chockalingam - STFC UKRI mailto:karthikeyan.chockalin...@stfc.ac.uk>> wrote: I tried adding the -mat_block_size 3 but I still get the same error message. Thanks, Karthik. From: Mark Adams mailto:mfad...@lbl.gov>> Date

Re: [petsc-users] Unstructured mesh

2021-12-13 Thread Karthikeyan Chockalingam - STFC UKRI
s] Unstructured mesh Try adding -mat_block_size 3 On Mon, Dec 13, 2021 at 11:57 AM Karthikeyan Chockalingam - STFC UKRI mailto:karthikeyan.chockalin...@stfc.ac.uk>> wrote: I tried to run the problem using -pc_type hypre but it errored out: ./ex56 -cells 4,4,2 -max_conv_its 1 -lx 1. -alph

Re: [petsc-users] Unstructured mesh

2021-12-13 Thread Karthikeyan Chockalingam - STFC UKRI
kills them. -- From: Mark Adams Date: Monday, 13 December 2021 at 13:58 To: "Chockalingam, Karthikeyan (STFC,DL,HC)" Cc: Matthew Knepley , "petsc-users@mcs.anl.gov" Subject: Re: [petsc-users] Unstructured mesh On Mon, Dec 13, 2021 at 8:35 AM Karthikeyan Chockalingam - STFC UKRI

Re: [petsc-users] Unstructured mesh

2021-12-13 Thread Karthikeyan Chockalingam - STFC UKRI
keyan (STFC,DL,HC)" Cc: Mark Adams , "petsc-users@mcs.anl.gov" Subject: Re: [petsc-users] Unstructured mesh On Mon, Dec 13, 2021 at 9:40 AM Karthikeyan Chockalingam - STFC UKRI mailto:karthikeyan.chockalin...@stfc.ac.uk>> wrote: @Mark Adams<mailto:mfad...

Re: [petsc-users] Unstructured mesh

2021-12-13 Thread Karthikeyan Chockalingam - STFC UKRI
quot;Chockalingam, Karthikeyan (STFC,DL,HC)" Cc: Matthew Knepley , "petsc-users@mcs.anl.gov" Subject: Re: [petsc-users] Unstructured mesh On Mon, Dec 13, 2021 at 8:35 AM Karthikeyan Chockalingam - STFC UKRI mailto:karthikeyan.chockalin...@stfc.ac.uk>> wrote: Thanks Ma

Re: [petsc-users] Unstructured mesh

2021-12-13 Thread Karthikeyan Chockalingam - STFC UKRI
nstructured mesh On Mon, Dec 13, 2021 at 7:15 AM Karthikeyan Chockalingam - STFC UKRI mailto:karthikeyan.chockalin...@stfc.ac.uk>> wrote: Thank you. I was able to confirm both the below options produced the same mesh ./ex56 -cells 2,2,1 -max_conv_its 2 ./ex56 -cells 4,4,2 -max_conv_it

Re: [petsc-users] Unstructured mesh

2021-12-13 Thread Karthikeyan Chockalingam - STFC UKRI
arthik. From: Mark Adams Date: Sunday, 12 December 2021 at 23:00 To: "Chockalingam, Karthikeyan (STFC,DL,HC)" Cc: Matthew Knepley , "petsc-users@mcs.anl.gov" Subject: Re: [petsc-users] Unstructured mesh On Sun, Dec 12, 2021 at 3:19 PM Karthikeyan Chockalingam - STFC UKRI ma

Re: [petsc-users] Unstructured mesh

2021-12-12 Thread Karthikeyan Chockalingam - STFC UKRI
ers@mcs.anl.gov" Subject: Re: [petsc-users] Unstructured mesh On Fri, Dec 10, 2021 at 1:11 PM Karthikeyan Chockalingam - STFC UKRI mailto:karthikeyan.chockalin...@stfc.ac.uk>> wrote: Thank you that worked. I have attached the output of the run ./ex56 -cells 2,2,1 -max_co

Re: [petsc-users] Unstructured mesh

2021-12-10 Thread Karthikeyan Chockalingam - STFC UKRI
: "Chockalingam, Karthikeyan (STFC,DL,HC)" Cc: "petsc-users@mcs.anl.gov" Subject: Re: [petsc-users] Unstructured mesh On Fri, Dec 10, 2021 at 10:49 AM Karthikeyan Chockalingam - STFC UKRI mailto:karthikeyan.chockalin...@stfc.ac.uk>> wrote: Thank you for your response. I tried

Re: [petsc-users] Unstructured mesh

2021-12-10 Thread Karthikeyan Chockalingam - STFC UKRI
: "Chockalingam, Karthikeyan (STFC,DL,HC)" Cc: "petsc-users@mcs.anl.gov" Subject: Re: [petsc-users] Unstructured mesh On Fri, Dec 10, 2021 at 7:42 AM Karthikeyan Chockalingam - STFC UKRI mailto:karthikeyan.chockalin...@stfc.ac.uk>> wrote: Hi Matt, I intend to perform

Re: [petsc-users] Unstructured mesh

2021-12-10 Thread Karthikeyan Chockalingam - STFC UKRI
day, 2 December 2021 at 10:57 To: "Chockalingam, Karthikeyan (STFC,DL,HC)" Cc: "petsc-users@mcs.anl.gov" Subject: Re: [petsc-users] Unstructured mesh On Thu, Dec 2, 2021 at 3:33 AM Karthikeyan Chockalingam - STFC UKRI mailto:karthikeyan.chockalin...@stfc.ac.uk>> wrote: Hel

[petsc-users] Hypre (GPU) memory consumption

2021-12-03 Thread Karthikeyan Chockalingam - STFC UKRI
Hello, I am able to successfully run hypre on gpus but the problem seems to consumption a lot of memory. I ran ksp/ksp/tutorial/ex45 on a grid of 320 x 320 x 320 using 6 gpus by the following options mpirun -n 6 ./ex45 -da_grid_x 320 -da_grid_y 320 -da_grid_z 320 -dm_mat_type hypre -dm_vec_t

[petsc-users] Unstructured mesh

2021-12-02 Thread Karthikeyan Chockalingam - STFC UKRI
Hello, Are there example tutorials on unstructured mesh in ksp? Can some of them run on gpus? Kind regards, Karthik. This email and any attachments are intended solely for the use of the named recipients. If you are not the intended recipient you must not use, disclose, copy or distribute thi

[petsc-users] GAMG memory consumption

2021-11-24 Thread Karthikeyan Chockalingam - STFC UKRI
Hello, I would like to understand why more memory is consumed by -pc_type gamg compared to -pc_type mg for the same problem size ksp/ksp/tutorial: ./ex45 -da_grid_x 368 -da_grid_x 368 -da_grid_x 368 -ksp_type cg -pc_type mg Maximum (over computational time) process memory:total 1.9399

Re: [petsc-users] hypre on gpus

2021-11-22 Thread Karthikeyan Chockalingam - STFC UKRI
On Mon, Nov 22, 2021 at 10:20 AM Karthikeyan Chockalingam - STFC UKRI mailto:karthikeyan.chockalin...@stfc.ac.uk>> wrote: Thanks Stefano, I just did a clean build with no problems. Can you try a clean build of main? Thanks, Matt I have another build without the --download-hypre-commi

Re: [petsc-users] hypre on gpus

2021-11-22 Thread Karthikeyan Chockalingam - STFC UKRI
ypre on gpus On Mon, Nov 22, 2021 at 10:20 AM Karthikeyan Chockalingam - STFC UKRI mailto:karthikeyan.chockalin...@stfc.ac.uk>> wrote: Thanks Stefano, I just did a clean build with no problems. Can you try a clean build of main? Thanks, Matt I have another build without the --do

Re: [petsc-users] hypre on gpus

2021-11-22 Thread Karthikeyan Chockalingam - STFC UKRI
v" Subject: Re: [petsc-users] hypre on gpus You don't need to specify the HYPRE commit. Remove --download-hypre-commit=origin/hypre_petsc from the configuration options Il giorno lun 22 nov 2021 alle ore 17:29 Matthew Knepley mailto:knep...@gmail.com>> ha scritto: On Mon,

Re: [petsc-users] hypre on gpus

2021-11-22 Thread Karthikeyan Chockalingam - STFC UKRI
. On Fri, Nov 19, 2021 at 10:47 AM Karthikeyan Chockalingam - STFC UKRI mailto:karthikeyan.chockalin...@stfc.ac.uk>> wrote: Hello, I tried to solve a 3D Poisson (ksp/tutorial/ex45) using -pc_type hypre on gpus ./ex45 -da_grid_x 128 -da_grid_y 128 -da_grid_z 128 -dm_mat_type hypre -dm

Re: [petsc-users] Debugger won't start

2021-11-15 Thread Karthikeyan Chockalingam - STFC UKRI
Thank you very much that worked! Best, Karthik. On 15/11/2021, 10:50, "Jose E. Roman" wrote: -start_in_debugger -debug_terminal "/path/to/xterm -e" > El 15 nov 2021, a las 11:06, Karthikeyan Chockalingam - STFC UKRI escribió: > > Thank you f

Re: [petsc-users] Debugger won't start

2021-11-15 Thread Karthikeyan Chockalingam - STFC UKRI
nov 2021, a las 9:55, Karthikeyan Chockalingam - STFC UKRI escribió: > > Hello, > > I am running PETSc 3.16.0 on a cluster compiled in debug mode using the flag -start_in_debugger. But I getting following error message: > > Unable to start debugger i

[petsc-users] Debugger won't start

2021-11-15 Thread Karthikeyan Chockalingam - STFC UKRI
Hello, I am running PETSc 3.16.0 on a cluster compiled in debug mode using the flag -start_in_debugger. But I getting following error message: Unable to start debugger in xterm. No such file or directory. I think the program is searching in the wrong path, probably under /usr/bin but xterm is

[petsc-users] Memory usage

2021-10-29 Thread Karthikeyan Chockalingam - STFC UKRI
Hello, I used the flags -memory_view -malloc_log to ran a problem on the same size on 32 cores and 64 cores. I understand what is total, max and min memory usage of the problem is. However I don’t understand the difference between Maximum and Current process memory? I also curious to unders

Re: [petsc-users] Cuda: Vec and Mat types

2021-10-27 Thread Karthikeyan Chockalingam - STFC UKRI
2:24 PM Karthikeyan Chockalingam - STFC UKRI mailto:karthikeyan.chockalin...@stfc.ac.uk>> wrote: Hello, I hope, I am framing the question currently. Are only distributed arrays (DMDA) of -vec_type and -mat_type only supported by CUDA? I don't understand this question. Currently, CUDA

[petsc-users] Cuda: Vec and Mat types

2021-10-27 Thread Karthikeyan Chockalingam - STFC UKRI
Hello, I hope, I am framing the question currently. Are only distributed arrays (DMDA) of -vec_type and -mat_type only supported by CUDA? I am reading the petsc user manual in section 2.4 distributed arrays are introduced but at the start of chapter two there are other vector and matrix types

[petsc-users] Building PETSc with Hypre GPU

2021-10-11 Thread Karthikeyan Chockalingam - STFC UKRI
Dear all, I would like to confirm if I have successfully build petsc with hypre gpu. I have attached my build python script file. Please let me know if I have it right? Kind regards, Karthik. This email and any attachments are intended solely for the use of the named recipients. If you are not

Re: [petsc-users] hypre on gpus

2021-10-08 Thread Karthikeyan Chockalingam - STFC UKRI
v" Subject: Re: [petsc-users] hypre on gpus Did you use -dm_mat_type hypre on the GPU case ? On Fri, Oct 8, 2021 at 12:19 PM Karthikeyan Chockalingam - STFC UKRI mailto:karthikeyan.chockalin...@stfc.ac.uk>> wrote: I tried a different exercise ran the same problem on two cpu core

Re: [petsc-users] hypre on gpus

2021-10-08 Thread Karthikeyan Chockalingam - STFC UKRI
: Friday, 8 October 2021 at 16:36 To: "Chockalingam, Karthikeyan (STFC,DL,HC)" Cc: "petsc-users@mcs.anl.gov" Subject: Re: [petsc-users] hypre on gpus On Fri, Oct 8, 2021 at 10:29 AM Karthikeyan Chockalingam - STFC UKRI mailto:karthikeyan.chockalin...@stfc.ac.uk>> wrote:

Re: [petsc-users] hypre on gpus

2021-10-08 Thread Karthikeyan Chockalingam - STFC UKRI
: Re: [petsc-users] hypre on gpus Hypre does not record its flops with PETSc's timers. Configure with and without CUDA and see if the timings change in PCApply. Hypre does not dynamically switch between CUDA and CPU solves at this time, but you want to use -dm_mat_type hypre. Mark On Fri, Oc

Re: [petsc-users] hypre on gpus

2021-10-08 Thread Karthikeyan Chockalingam - STFC UKRI
i, Oct 8, 2021 at 6:59 AM Karthikeyan Chockalingam - STFC UKRI mailto:karthikeyan.chockalin...@stfc.ac.uk>> wrote: Hello, I am trying to run ex45 (in KSP tutorial) using hypre on gpus. I have attached the python configuration file and -log_view output from running the below command option

[petsc-users] hypre on gpus

2021-10-08 Thread Karthikeyan Chockalingam - STFC UKRI
Hello, I am trying to run ex45 (in KSP tutorial) using hypre on gpus. I have attached the python configuration file and -log_view output from running the below command options mpirun -n 2 ./ex45 -log_view -da_grid_x 169 -da_grid_y 169 -da_grid_z 169 -dm_mat_type mpiaijcusparse -dm_vec_type mp

Re: [petsc-users] (percent time in this phase)

2021-10-05 Thread Karthikeyan Chockalingam - STFC UKRI
Matthew Knepley , "petsc-users@mcs.anl.gov" Subject: Re: [petsc-users] (percent time in this phase) On Oct 5, 2021, at 12:28 PM, Karthikeyan Chockalingam - STFC UKRI mailto:karthikeyan.chockalin...@stfc.ac.uk>> wrote: Thanks Barry. Please find the attached screen shoot (flame

Re: [petsc-users] (percent time in this phase)

2021-10-05 Thread Karthikeyan Chockalingam - STFC UKRI
ingam, Karthikeyan (STFC,DL,HC)" Cc: Matthew Knepley , "petsc-users@mcs.anl.gov" Subject: Re: [petsc-users] (percent time in this phase) On Oct 5, 2021, at 12:28 PM, Karthikeyan Chockalingam - STFC UKRI mailto:karthikeyan.chockalin...@stfc.ac.uk>> wrote: Thanks Barry.

Re: [petsc-users] (percent time in this phase)

2021-10-05 Thread Karthikeyan Chockalingam - STFC UKRI
ject: Re: [petsc-users] (percent time in this phase) PCSetUpOnBlocks() calls KSPSetUp() on each block which calls PCSetUp() on each block. This is why you are getting the confusing logging results. So the " extra" KSPSetUp() is the one on the blocks. On Oct 5, 2021,

Re: [petsc-users] (percent time in this phase)

2021-10-05 Thread Karthikeyan Chockalingam - STFC UKRI
t 3, 2021 at 5:43 AM Karthikeyan Chockalingam - STFC UKRI mailto:karthikeyan.chockalin...@stfc.ac.uk>> wrote: Hi Matt, Thank you. The flamegraph tool is helpful. Please find the attached screen shoot and foo.txt which generated that graph (using https://www.speedscope.app). I find the following ca

  1   2   >