Skip to main content

Questions tagged [petsc]

PETSc is an open source suite of data structures and routines for the scalable (parallel) solution of scientific applications modeled by partial differential equations.

Filter by
Sorted by
Tagged with
1 vote
0 answers
48 views

I’m solving the 3D incompressible Navier–Stokes equations in parallel using stabilized finite elements (SUPG + PSPG). The flow is turbulent, with a Reynolds number around 10^6 . The domain has both ...
Priyanshu's user avatar
1 vote
0 answers
56 views

I am implementing a 2D elasto-plastic phase-field fracture model under plane strain conditions using a staggered approach. The solver iteratively updates displacement and phase-field damage until ...
KUMAR SAURAV 21920037's user avatar
3 votes
0 answers
118 views

In my problem, steady fluid flow is considered, and instead of three-dimensional computational fluid dynamics methods, some simplified version is used. I am trying to implement a coupled solution ...
EvgeniyMist's user avatar
1 vote
1 answer
155 views

I am trying to implement a numerical solver for the Complete Electrode Model (CEM) of Electrical Impedance Tomography (EIT). In a domain $\Omega$ with $L\in\mathbb{N}$ electrodes $\Gamma_l\subset\...
Rui Martins's user avatar
3 votes
0 answers
103 views

In the context of preconditioning saddle point problems (for instance, arising from PDEs) people are interested in solving (generalised) eigenvalue problems associated with the Schur complement $BA^{-...
FEGirl's user avatar
  • 575
2 votes
0 answers
126 views

I am trying to solve the Stokes equation containing viscosity nonlinearity using the open source finite element software underworld2 with nested PETSc. The resolution is 2000*200. The solution results ...
Darcy's user avatar
  • 21
0 votes
0 answers
94 views

The PETSc documentation example of a non-linear solver call has the user provide separate functions for the Jacobian and function evaluations: ...
Sardine's user avatar
  • 376
0 votes
0 answers
71 views

In snes/tutorials/ex13.c, there is a function SetupPrimalProblem(), which sets up the $f_0$ and $f_1$ in ...
durianice's user avatar
  • 101
0 votes
1 answer
316 views

Considering the following COO sparse matrix format, with repeated indices: ...
Ponyboy Curtis's user avatar
1 vote
0 answers
95 views

Currently, I use Eigen3 for linear algebra operations on sparse matrices and either UMFPACK or CHOLMOD from SuiteSparse to solve sparse linear systems. However, as my model grows larger and the need ...
Ponyboy Curtis's user avatar
2 votes
1 answer
210 views

I'm solving $Ax = b$ with PETSc, $A$ sparse and asymmetric. I'm using BCGS or FGMRES or TFQMR as a solver, and ILU as a preconditioner. When I use 1 core, everything works as expected. But with 8 ...
Lilla's user avatar
  • 259
3 votes
0 answers
168 views

I have experience with classical linear algebra packages in C++ like Eigen, Blaze, etc. I have never wrote my own PetSC back-end solver but I used/modified several of them. In a new project I would ...
Kürşat Yurt's user avatar
1 vote
1 answer
222 views

I have a problem when using petsc. I want to solve a series of linear equations. A1x1=b1, A2x2=b2, A3*x3=b3 ... The A1,A2,A3 have the same sparstiy pattern. I want to use MUMPS to solve the system. In ...
Xu Hui's user avatar
  • 323
6 votes
1 answer
625 views

I want to build an application for Material Point Method (and probably other meshfree methods too) in Julia and I am looking for library for direct and iterative solvers that can help me with it. One ...
lokit khemka's user avatar
0 votes
0 answers
104 views

I am using petsc to solve a linear elasticity problem discretized by finite elements.The initial mesh is read by a mesh file and the distribution in each processor is done using METIS.I am using only ...
Spy123's user avatar
  • 21

15 30 50 per page
1
2 3 4 5
11