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.
162 questions
- Bountied 0
- Unanswered
- Frequent
- Score
- Trending
- Week
- Month
- Unanswered (my tags)
1
vote
0
answers
55
views
Why does my elasto-plastic phase-field fracture model fail at low H/E ratios (linear hardening) and in all nonlinear hardening cases?
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 ...
3
votes
0
answers
116
views
Lack of convergence in a coupled fluid dynamics solver using Newton's method
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 ...
1
vote
1
answer
153
views
FEM discretization of Electrical Impedance Tomography on Firedrake or PETSc (or maybe Fenics?)
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\...
3
votes
0
answers
99
views
How to approach eigenvalue problem with Schur complement?
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^{-...
2
votes
0
answers
123
views
Why multigrid is inefficient?
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 ...
0
votes
0
answers
92
views
PETSc non-linear solvers (SNES): specifying single Eval & Jacobian function
The PETSc documentation example of a non-linear solver call has the user provide separate functions for the Jacobian and function evaluations:
...
0
votes
0
answers
70
views
PETSC: Solving a simpler PDE results in error while solving the original equation works in snes/tutorials/ex13.c
In snes/tutorials/ex13.c,
there is a function SetupPrimalProblem(),
which sets up the $f_0$ and $f_1$ in ...
0
votes
1
answer
314
views
How to efficiently fill in, in parallel, a PETSc matrix from a COO sparse matrix?
Considering the following COO sparse matrix format, with repeated indices:
...
1
vote
0
answers
92
views
How can I optimize the solution of linear systems in my Finite Element Method code for solving nonlinear computational mechanics problems?
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 ...
2
votes
1
answer
209
views
Solution of linear system doesn't work, in parallel
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 ...
3
votes
0
answers
167
views
Starting point to use Trilinos linear algebra packages?
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 ...
1
vote
1
answer
221
views
How to reuse the symbolic factorization when using MUMPS in petsc?
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 ...
6
votes
1
answer
619
views
PETSc-like library for Julia
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 ...
0
votes
0
answers
104
views
Output solution vector in Petsc
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 ...
2
votes
1
answer
752
views
How to solve a linear problem A x = b in PETSC when matrix A has zero diagonal enteries?
I am solving a structural mechanics problem that involves setting constraints, and I use Lagrange multipliers to set it. Consequently, some diagonal entries of the tangent stiffness matrix vanish, and ...