Hi,
When solving an eigenproblem with Dirichlet constraints on some of the DoFs,
I have so far been creating a new matrix including only the unconstrained
rows/columns and the calling the eigensolver on that. This works without
issues.
I am writing to check if there are other recommen
I can verify that my application code is working with mpich-3.3.2 .
-Manav
> On Aug 21, 2020, at 11:55 AM, Manav Bhatia wrote:
>
> I built petsc with mpich-3.3.2 on my MacBook Pro with Apple clang 11.0.3 and
> the test is finishing at my end.
>
> So, it appears that t
t; rank: 2 : Finished mat assembly
> rank: 4 : Finished mat assembly
> rank: 6 : Finished mat assembly
>
> --Junchao Zhang
>
>
> On Thu, Aug 20, 2020 at 5:29 PM Junchao Zhang <mailto:junchao.zh...@gmail.com>> wrote:
> I will have a look and report back to you. Th
d mat assembly
> rank: 7 : Finished mat assembly
> rank: 0 : Finished mat assembly
> rank: 5 : Finished mat assembly
> rank: 2 : Finished mat assembly
> rank: 4 : Finished mat assembly
> rank: 6 : Finished mat assembly
>
> --Junchao Zhang
>
>
> On Thu, Aug 20, 2020 at 5:29 PM Jun
let me know if I can provide any further information.
Thank you all for your help.
Regards,
Manav
> On Aug 20, 2020, at 12:54 PM, Jed Brown wrote:
>
> Matthew Knepley mailto:knep...@gmail.com>> writes:
>
>> On Thu, Aug 20, 2020 at 11:09 AM Manav Bhatia wrote:
>>
> On Aug 20, 2020, at 11:21 AM, Stefano Zampini
> wrote:
>
>
>
>> On Aug 20, 2020, at 5:59 PM, Manav Bhatia > <mailto:bhatiama...@gmail.com>> wrote:
>>
>>
>>
>>> On Aug 20, 2020, at 8:31 AM, Stefano Zampini >> <mailto:s
> On Aug 20, 2020, at 8:31 AM, Stefano Zampini
> wrote:
>
> ((Mat_SeqAIJ*)aij->B->data)->nonew
> mat->was_assembled
> aij->donotstash
> mat->nooffprocentries
>
The values for the last three variables are all False on all 8 processes.
Regards,
Manav
> On Aug 20, 2020, at 10:22 AM, Junchao Zhang wrote:
>
> See if you could reproduce the problem on another machine, e.g., a Linux
> workstation with MPICH?
Yes, the same behavior happened on another machine with Centos 7 with an older
build of PETSc.
> On Aug 20, 2020, at 8:31 AM, Stefano Zampini
> wrote:
>
> Can you add a MPI_Barrier before
>
> ierr = MatAssemblyBegin(aij->A,mode);CHKERRQ(ierr);
>
With a MPI_Barrier before this function call:
— three of the processes have already hit this barrier,
— the other 5 are inside MatStashSc
: is this the first matrix assembly of the code?
> If you change to pc_none, do you get the same issue?
>
>> On Aug 20, 2020, at 3:10 PM, Manav Bhatia > <mailto:bhatiama...@gmail.com>> wrote:
>>
>>
>>
>>> On Aug 19, 2020, at 9:39 PM, Matthew
> On Aug 19, 2020, at 9:39 PM, Matthew Knepley wrote:
>
> Jed is more knowledgeable about the communication, but I have a simple
> question about the FEM method. Normally, the way
> we divide unknowns is that the only unknowns which might have entries
> computed off-process are those on the p
> On Aug 19, 2020, at 7:56 PM, Jed Brown wrote:
>
> Manav Bhatia writes:
>
>> Thanks for the followup, Jed.
>>
>>> On Aug 19, 2020, at 7:42 PM, Jed Brown wrote:
>>>
>>> Can you share a couple example stack traces from that debugging?
&
This is a 3D elasticity run with Hex8 elements. So, each row has 81 non-zero
entries, although I have not verified that (I will do so now). Is there a
command line argument that will print this for the matrix? Although, on second
thought that will not be printed unless the Assembly routine has finished.
(GNHEP) you should not see this problem. The only
> precaution is not to solve systems with matrix B, e.g., using
> shift-and-invert.
>
> Jose
>
>
>> El 5 dic 2019, a las 5:04, Manav Bhatia escribió:
>>
>> Hi,
>>
>> I am working on mixed form
Hi,
I am working on mixed form finite element discretization which leads to
eigenvalues of the form
A x = lambda B x
With the matrices defined in a block structure as
A =[ K D^T ]
[ D 0 ]
B = [ M 0 ]
[ 0 0 ]
The second row of equations c
oughts concerning this.
Regards,
Manav
> On May 29, 2019, at 9:11 PM, Manav Bhatia wrote:
>
> Barry,
>
> Thanks for the detailed message.
>
>I checked libMesh’s continuation sovler and it appears to be using the
> same system solver without creating a larger matrix:
; The message User provided function() line 0 in unknown file indicates the
> crash took place OUTSIDE of PETSc code and error message INTERNAL Error:
> recvd root arrowhead is definitely not coming from PETSc.
>
>Yes, debug with the debug version and also try valgrind.
>
need.
>
> Some notes:
>
> - 2) and 3) can be swapped
> - 5) MatXAIJSetPreallocation can be called instead
>
> Let me know if you need further clarifications
> Stefano
>
>> On Dec 28, 2018, at 9:05 PM, Manav Bhatia via petsc-users
>> mailto:petsc-users@m
Hi,
I am currently accessing PETSc through libMesh where the matrices of type
MPIAIJ are being initialized using the MatSetSizes, MatSetFromOptions, and
MatMPIAISetPreallocation calls.
I am interested in accessing the BDDC solver and have looked through the PDF
manual that talks about
gt;
>
>> On Oct 29, 2018, at 12:59 PM, Manav Bhatia wrote:
>>
>> Thanks for the clarification.
>>
>> I also observed that the number of KSP iterations increases with an increase
>> in the levels of AMG. Is this true, in general, for all/most applicat
y for the coarsening step in a MG (?).
I would appreciate some guidance.
Regards,
Manav
> On Oct 29, 2018, at 1:57 PM, Jed Brown wrote:
>
> Manav Bhatia writes:
>
>> I am experimenting with the threshold parameter.
>>
>> As described in the manual:
>> ht
This is really helpful, Jed!
Thanks,
Manav
> On Oct 29, 2018, at 1:57 PM, Jed Brown wrote:
>
> Manav Bhatia writes:
>
>> I am experimenting with the threshold parameter.
>>
>> As described in the manual:
>> https://www.mcs.anl.gov/pet
magnitudes of the entries in the
matrix (?).
I would appreciate some guidance here.
Regards,
Manav
> On Oct 29, 2018, at 1:03 PM, Jed Brown wrote:
>
> Manav Bhatia writes:
>
>> I also observed that the number of KSP iterations increases with an increase
>> in
Thanks!
> On Oct 29, 2018, at 1:03 PM, Jed Brown wrote:
>
> Manav Bhatia writes:
>
>> I also observed that the number of KSP iterations increases with an increase
>> in the levels of AMG. Is this true, in general, for all/most applications?
>
> Adding levels
Thanks for the clarification.
I also observed that the number of KSP iterations increases with an increase in
the levels of AMG. Is this true, in general, for all/most applications?
-Manav
> On Oct 29, 2018, at 12:53 PM, Jed Brown wrote:
>
> Manav Bhatia writes:
>
&g
e:
>
> https://www.mcs.anl.gov/petsc/petsc-current/docs/manualpages/PC/PCGAMGSetSquareGraph.html
>
> Squaring the graph speeds up coarsening at the expense of convergence
> rate.
>
> Manav Bhatia writes:
>
>> Hi,
>>
>> I am trying to understand the
increase convergence rate at all costs. Once we
> our best rate we should be able to back off of some of this without much
> degradation or play around with the parameters to optimize run time.
>
>
> On Sun, Oct 28, 2018 at 5:13 PM Manav Bhatia <mailto:bhatiama...@gmail.com>&g
, theta_z to be zero for the solution, which ends up being the
case.
If I plot the solution, they look sensible, but the reduction of KSP norm is
slow.
Thanks,
Manav
> On Oct 28, 2018, at 3:55 PM, Smith, Barry F. wrote:
>
>
>
>> On Oct 28, 2018, at 12:16 PM, M
Hi,
I am attempting to solve a Mindlin plate bending problem with AMG solver in
petsc. This test case is with a mesh of 300x300 elements and 543,606 dofs.
The discretization includes 6 variables (u, v, w, tx, ty, tz), but only
three are relevant for plate bending (w, tx, ty).
I am
23 oct 2018, a las 16:10, Manav Bhatia escribió:
>>
>> Thanks for the clarification.
>>
>> Does this also apply to the standard non-hermitian eigenvalue problem? Do I
>> need to compile with complex numbers if I want to capture the complex
>> eigenvalu
Jose
>
>
>> El 22 oct 2018, a las 22:01, Manav Bhatia escribió:
>>
>> Thanks, Jose.
>>
>> How difficult would it be to add the support for the general case (if at all
>> possible)?
>>
>> My eigenvalue problem is of the form shown i
As a followup to this, if I am using a shell matrix for eigensolution (linear
or nonlinear eigenproblems), what operations should be defined for the shell
matrix?
-Manav
> On Oct 22, 2018, at 2:05 PM, Manav Bhatia wrote:
>
> Hi,
>
> I am exploring the nonlinear eigenvalue
Hi,
I am exploring the nonlinear eigenvalue problem solver in Slepc.
From the notes in "Sec 6.4: Retrieving the Solution”, it appears that if I
expect to find complex eigenpairs then I must compile the library (and Petsc)
with complex scalars. Is that correct?
Is there a way to inc
-and-invert to compute eigenvalues of (M0,M1) closest to the target
> sigma=0. If M0 is singular, then use a small nonzero value for sigma.
>
> Jose
>
>
>> El 7 sept 2018, a las 8:44, Manav Bhatia escribió:
>>
>> Hi,
>>
>> I am attempt
libraries
will be viewed favorably.
Interested people are encouraged to respond to mb2...@msstate.edu
<mailto:mb2...@msstate.edu> with a CV.
Regards,
Manav
Manav Bhatia, PhD
Assistant Professor
Department of Aerospace Engineering
Center for Advanced Vehicular Systems
Graduate Coord
Got it!
Thanks,
Manav
> On Mar 29, 2018, at 4:13 PM, Jed Brown wrote:
>
> Manav Bhatia writes:
>
>> Thanks, Matt.
>>
>> I also read page 72 in the manual about creating and assembling matrices.
>>
>> Just so that I understand correctly, Mat
manual says that this provides a “view” matrix, so any updates to this
submatrix should show up in the global?
How is MatCreateSubMatrixVirtual different? Is this different from a “view”
matrix?
> On Mar 29, 2018, at 3:10 PM, Matthew Knepley wrote:
>
> On Thu, Mar 29, 2018 at 3:28
Hi,
I have quick questions about MatCreateSubMatrix:
— Once the sub matrix is created, do I need to keep the IS (isrow and iscol) in
memory till this matrix is active, or can I destroy it immediately after the
creation of the matrix and continue to use the matrix?
— Is the assembly begin/e
>
> Fande,
>
>Thanks for the pointer.
>
>Satish determined the correct long term fix and it is in the branch
> barry/fix-lto_library-option-maint and will be put in the maint branch and
> master branch if it passes the testing tonight.
>
> Barry
>
>
^
mumps_c.c:107:28: note: passing argument to parameter 'nnz_loc' here
MUMPS_INT8 *nnz_loc,
^
2 warnings and 4 errors generated.
> On Oct 30, 2017, at 11:36 AM, Kong, Fande wrote:
>
> We
> somehow related to gfortran. A simple way to work around for us is to change
> if with_rpath: to if False at line 54 of
> config/BuildSystem/config/libraries.py.
>
> Not sure if it works for you.
>
> Fande,
>
>
>
>
> On Mon, Oct 30, 2017 at 10:14 AM
se.
>
> My guess is that your "Newton direction" is not a Newton (descent)
> direction at the second time step. So something is wrong with the generation
> of the Jacobian at the second time step.
>
> Barry
>
>
>
>> On Apr 20, 2017, at 2:40 PM,
Function norm 1.732147071753e+06
Nonlinear solve converged due to CONVERGED_SNORM_RELATIVE iterations 1
> On Apr 20, 2017, at 2:38 PM, Barry Smith wrote:
>
>
> Run with -snes_monitor also and send the output
>
>
>> On Apr 20, 2017, at 2:30 PM, Manav Bhatia wrote
Hi,
I have a time-dependent multiphysics problem that I am trying to solve using
pc_fieldsplit. I have defined a nested matrix for the jacobian with the
diagonal block matrices explicitly created and the off-diagonal blocks defined
using shell matrices, so that the matrix vector product is
It was a library from a colleague, particularly for internal use. So, this will
not perpetuate to your users. I appreciate your concern and support.
We will fix this at our end.
-Manav
> On Apr 8, 2017, at 11:28 PM, Barry Smith wrote:
>
>
>> On Apr 8, 2017, at 11:21 P
gt;
>>
>>> On Apr 7, 2017, at 3:34 PM, Manav Bhatia wrote:
>>>
>>> Yes, I printed the data in both cases and they look the same.
>>>
>>> I also used “set step-mode on” to show the system lapack info, and they
>>> both are using t
r 7, 2017, at 2:57 PM, Manav Bhatia wrote:
>>
>> Hi Barry,
>>
>> Thanks for the inputs.
>>
>> I did try that, but the debugger (gdb) stepped right over the dgeev_ call,
>> without getting inside the function.
>
> Did it at least stop at the fu
.
Thoughts?
Regards,
Manav
> On Apr 7, 2017, at 2:40 PM, Barry Smith wrote:
>
>
>> On Apr 7, 2017, at 1:46 PM, Manav Bhatia wrote:
>>
>> Hi,
>>
>> I have compile petsc on my Ubuntu machine (also Mac OS 10.12 separately)
>> to link to the
Hi,
I have compile petsc on my Ubuntu machine (also Mac OS 10.12 separately) to
link to the system lapack and blas libraries (shown below).
I have created an interface class to dgeev in lapack to calculate the
eigenvalues of a matrix.
My application code links to multiple librarie
Thanks Jose!
What would be a good way to calculate null space of A^2? Would I need to create
a shell matrix for A^2 and define matrix-vector products on this?
-Manav
> On Mar 26, 2017, at 2:56 AM, Jose E. Roman wrote:
>
>
>> El 26 mar 2017, a las 5:17, Manav Bhatia escr
Hi,
My code currently uses Petsc for all linear/nonlinear solution
functionality. I am looking to see if I can tap into Trilinos LOCA framework
for bifurcation problems without having to reimplement all solver interfaces in
my code. I noticed that Petsc currently is able to tap into the ML
Hi,
I am working on some continuation problems and need to approximate the null
space of a matrix for bifurcation and branch switching.
Are there algorithms available in Petsc to do this? Can Slepc be used to
calculate the null space of a matrix? I guess the eigenvectors corresponding t
ird, and prone to errors it seems to me. Perhaps this needs to be
> rethought
>
>>
>> Thanks,
>> Dave
>>
>>
>> On Wed, 8 Feb 2017 at 22:51, Manav Bhatia wrote:
>> aha.. that might be it.
>>
>> Does that need to be called for
aha.. that might be it.
Does that need to be called for the global matrix after each assembly of the
Jacobian blocks, or just once for the whole matrix?
-Manav
> On Feb 8, 2017, at 3:47 PM, Barry Smith wrote:
>
>
>> On Feb 8, 2017, at 3:40 PM, Manav Bhatia wrote:
>>
Hi,
I have a nested matrix with 2x2 blocks. The blocks (1,1) and (2,2) are AIJ
matrices and blocks (1,2) and (2,1) and shell matrices. I am calling the code
with the following arguments: -pc_type fieldsplit , and get the error shown
below.
I see that the error is complaining about the
Hi,
If I am using SNES and am calling SNESSetFromOptions, do I need to still
call the xxxSetForOptions for mat, vec, ksp and pc? If so, what is the
recommended order of these calls?
Thanks,
Manav
bs=2
total: nonzeros=83105344, allocated nonzeros=83266816
total number of mallocs used during MatSetValues calls =0
block size is 2
-Manav
> On Nov 15, 2016, at 3:34 PM, Barry Smith wrote:
>
>>
>> On Nov 15, 2016, at 3:23 PM, Manav Bhatia wrote:
>>
>>
> On Nov 15, 2016, at 3:34 PM, Barry Smith wrote:
>
>In PETSc we call this 2x2 block Jacobi "point-block Jacobi" you can use
> the option -pc_type pbjacobi. The ILU() in PETSc can also be "point block",
> this is obtained with the usual -pc_type ilu (that is there is no different
> prec
quot;block" they really don't have
> anything to do with each other.
>
> Barry
>
>> On Nov 15, 2016, at 3:03 PM, Manav Bhatia wrote:
>>
>> Hi,
>>
>> I am setting up a matrix with the following calls. The intent is to solve
>> the
Hi,
I am setting up a matrix with the following calls. The intent is to solve
the system with a 2x2 block size.
What combinations of KSP/PC will effectively translate to solving this block
matrix system?
I saw a discussion about bjacobi in the manual with the following calls (I
omi
> On Jul 25, 2016, at 3:43 PM, Matthew Knepley wrote:
>
> Yes. I think the confusion here is between the problem you are trying to
> solve, and the tool for doing it.
>
> Disparate size of subsystems seems to me to be a _load balancing_ problem.
> Here you can use data layout to alleviate thi
that there is no
confusion about these operations?
Thanks,
Manav
> On Jul 25, 2016, at 3:21 PM, Matthew Knepley wrote:
>
> On Mon, Jul 25, 2016 at 1:13 PM, Manav Bhatia <mailto:bhatiama...@gmail.com>> wrote:
> Hi,
>
> I have a multi physics application with d
Hi,
I have a multi physics application with discipline1 defined on comm1 and
discipline2 on comm2.
My intent is to use the nested matrix for the KSP solver where each
diagonal block is provided by the disciplines, and the off-diagonal blocks are
defined as shell-matrices with matrix ve
ome DMXXX unless you have a good reason. Each
> DMXXX is for a particular class of problems/algorithms and you pick the DMXXX
> to use based on what you are doing. So use DMForest if you wish to use
> oct-trees, etc.
>
> Barry
>
>
>
>> On Jul 23, 2016, at 1
Hi,
I am new to the DM constructs. I am curious if there is a compelling reason
to move from handling IS sets to DM data structures.
My applications are built on top of libMesh. They used IS sets for a long
time, and in recent years I have seen DM constructs in the library. However, I
ignore all eigenvalues less than 0?
Thanks,
Manav
> On Apr 4, 2016, at 11:30 AM, Jose E. Roman wrote:
>
>
>> El 4 abr 2016, a las 18:23, Manav Bhatia escribió:
>>
>> Thanks, Jose!
>>
>> I am currently running 3.6.2, and will update to 3.6.3.
&g
e E. Roman wrote:
>
>>
>> El 4 abr 2016, a las 18:06, Manav Bhatia escribió:
>>
>> Hi Jose,
>>
>> I also read these matrices into matlab and found the eigenvalues as
>>
>>>> A = PetscBinaryRead('A.petsc’);
>>>> B = P
MPI_COMM_WORLD
with errorcode 76.
NOTE: invoking MPI_ABORT causes Open MPI to kill all MPI processes.
You may or may not see output from other processes, depending on
exactly when Open MPI kills them.
--
> On Apr 4, 20
I just sent you the updated matrices on slepc-main.
Sorry about sending the wrong matrices earlier.
Regards,
Manav
> On Apr 4, 2016, at 9:42 AM, Manav Bhatia wrote:
>
> Ok. So, I ran ex7 with the same command-line options in your email, and got a
> result. This is on my Mac O
from my code at load step
13.
I will try to output the offending matrices and share those with you.
Regards,
Manav
> On Apr 4, 2016, at 9:47 AM, Jose E. Roman wrote:
>
>
>> El 4 abr 2016, a las 16:42, Manav Bhatia escribió:
>>
>> Ok. So, I ran ex7 with the same c
MatSetValues calls =0
using I-node routines: found 2050 nodes, limit used is 5
doing matmult as a single matrix-matrix product
> On Apr 4, 2016, at 9:47 AM, Jose E. Roman wrote:
>
>
>> El 4 abr 2016, a las 16:42, Manav Bhatia escribió:
>>
>> Ok.
mac.
Not sure how to go about debugging this.
-Manav
> On Apr 4, 2016, at 3:46 AM, Jose E. Roman wrote:
>
>
>> El 3 abr 2016, a las 22:17, Manav Bhatia escribió:
>>
>> I just send you the matrices.
>>
>> Thanks,
>> Manav
>
> I cann
what I find.
Thanks again!
Manav
> On Apr 4, 2016, at 3:46 AM, Jose E. Roman wrote:
>
>
>> El 3 abr 2016, a las 22:17, Manav Bhatia escribió:
>>
>> I just send you the matrices.
>>
>> Thanks,
>> Manav
>
> I cannot reproduce the pro
I just send you the matrices.
Thanks,
Manav
> On Apr 3, 2016, at 3:03 PM, Jose E. Roman wrote:
>
>
>> El 3 abr 2016, a las 21:45, Manav Bhatia escribió:
>>
>> Hi Jose,
>>
>> I did not specify Arnoldi. I am running on a single CPU, so maybe Ar
ote:
>
>
>> El 3 abr 2016, a las 20:47, Manav Bhatia escribió:
>>
>> Hi,
>>
>> I am using slepc to solve for the natural frequencies of a
>> small-disturbance modal eigensolution of a plate with compressive stresses.
>>
>> M x =
Hi,
I am using slepc to solve for the natural frequencies of a small-disturbance
modal eigensolution of a plate with compressive stresses.
M x = (1/omega^2) K(lambda) x
lambda is the loading parameter. I first solve for the nonlinear static
solution for a given load, which
Hi,
My interest is in running two separate KSP contexts on two subsets of the
global mpi communicator context. Is there an example that demonstrates this?
My intention is for the two subsets to have an overlap. For example, on a 4
processor global communicator (0, 1, 2, 3), one subset
Hi,
Is there explicit support for second-order systems arising from structural
dynamics in the TS library?
It can certainly be written as an equivalent first-order system, but some
structural dynamics simulations prefer to tune the two-parameter Newmark
solvers to provide extra damping
> On Mar 9, 2016, at 10:19 AM, Jed Brown wrote:
>
> Manav Bhatia writes:
>
>> Thanks!
>>
>> I am intrigued by this.
>>
>> I am solving a system of equations where the natural block size is
>> 2x2. This is obtained by rewriting a compl
method works only for blocked matrix. So, to make the
code generic, I will need to use the explicit row/column numberings along with
a MatSetValues method.
-Manav
> On Mar 9, 2016, at 8:59 AM, Barry Smith wrote:
>
>
>> On Mar 9, 2016, at 8:43 AM, Manav Bhatia wrote:
>>
Hi,
Out of GAMG, ML and HYPRE, which are expected to be compatible with SEQBAIJ
and MPIBAIJ matrices?
Regards,
Manav
Thanks. That means I am doing something goofy in setting up my matrix.
I am trying to create a matrix with block size 2, and 3000 as the number of
block rows/columns. So, I would expect an output of 6000x6000 from the
following code, but I get 3000x3000. Is it the sequence of my function calls?
Hi
Is MatGetSize for a SeqBAIJ matrix expected to return the number of block
rows and columns, or the total number of rows and columns (blocks rows times
block size)?
Thanks,
Manav
Hi,
VecGetValuesBlocked is referenced by some documentation pages
(http://www.mcs.anl.gov/petsc/petsc-3.6/docs/manualpages/Vec/VecGetValues.html),
but does not seem to be in the code any more.
Is VecGetValues the default method to get values from blocked storage of
vectors as well? If so,
erator without boundary
> conditions" to the web page doc for MatSetNearNullSpace.
>
> On Wed, Feb 24, 2016 at 10:57 AM, Matthew Knepley <mailto:knep...@gmail.com>> wrote:
> On Wed, Feb 24, 2016 at 9:45 AM, Manav Bhatia <mailto:bhatiama...@gmail.com>> wrote:
> Hi,
&
Hi,
I am working on a problem with system of equations in complex numbers, and am
splitting it up to solve it with petsc compiled for real number support:
(J_R + i J_I) (x_R + i x_I) + (r_R + i r_I) = 0
is then defined as
[ J_R -J_I] {x_R} + {r_R} = {0}
[ J_IJ_R] {x_I} + {r_I}
Hi,
I am attempting to compile petsc 3.6.3 on my mac with the following options:
./configure --prefix=${PWD}/../ --CC=mpicc --CXX=mpicxx --FC=mpif90
--with-clanguage=c++ --with-fortran=0
--with-mpi-include=/opt/local/include/openmpi-mp
--with-mpiexec=/opt/local/bin/mpiexec
-with-mpi-
Hi,
I typically apply Dirichlet BCs by modifying the Jacobin and rhs: zero
constrained rows of matrix with 1.0 at diagonal, and zero corresponding rows of
rhs.
While using GAMG, is it still recommended to provide the near-null space
(given that the zero-eigenvalues have been removed
e fill factor (so it is a lot like a direct solver) and
> even then it is working really poorly. You should google for good
> preconditioners for transonic Euler flow and SUPG (and ignore anything that
> mentions ILU) to get a handle on how PCFIELDSPLIT could be used for your
> pro
Hi,
I am solving a transonic Euler flow problem discretized with SUPG. The mesh
is made of Tet4 elements and there are about 7M dofs, which I am trying to
solve over 192 cores.
I had earlier written about the linear solver returning with Inf, and have
since moved beyond that such that I
> Barry
>
>> On Mar 26, 2015, at 11:20 AM, Manav Bhatia wrote:
>>
>> Thanks.
>> Quick question (out of ignorance): does it matter that the HEX8 may still be
>> arranged in an unstructured fashion? Meaning, that although I use brick
>> elements,
t;
>> On Mar 26, 2015, at 10:51 AM, Manav Bhatia wrote:
>>
>> Barry,
>>
>> On a related note, I have another elasticity problem that I am trying to
>> solver with HEX8 elements. It is an isotropic solid structure. Do you have a
>> recommended pre
U(0) on each process is not appropriate for
> your problem and is producing overflow. Try -sub_pc_type lu and see if that
> produces a different result.
>
> Is this a Stokes-like problem?
>
> Barry
>
>> On Mar 26, 2015, at 10:10 AM, Manav Bhatia wrote:
>>
>
used during MatSetValues calls =0
using I-node (on process 0) routines: found 133414 nodes, limit used is 5
Anything jumps out at you as odd?
-Manav
> On Mar 26, 2015, at 9:34 AM, Matthew Knepley wrote:
>
> On Thu, Mar 26, 2015 at 9:21 AM, Manav Bhatia <mailto:bhatiama.
Hi,
I am using the KSP linear solver for my system of equations, without any
command line options at this point. I have checked that the L1 norms of my
system matrix and the force vector are finite values, but the KSP solver is
returning with an “inf” residual in the very first iteration.
I got the code to work with a consistent combination of mpi and gcc compilers.
Thanks for your help!
-Manav
> On Mar 11, 2015, at 2:35 PM, Barry Smith wrote:
>
>
>> On Mar 11, 2015, at 1:50 PM, Manav Bhatia wrote:
>>
>>
>>> On Mar 11, 2
--
Number of SNES iterations = 4
Completed test examples
=
Now to evaluate the computer systems you plan use - do:
make PETSC_DIR=/work/bhatia/codes/shadow/petsc/petsc-3.5.3
PETSC_ARCH=arch-linux2-cxx-opt streams NPMAX=
shadow-login[239] bhatia$
> On Mar 11, 2015, a
Agreed.
I am attempting to recompile with a single compiler to maintain consistency.
Hopefully, I will be able to make more progress.
-Manav
> On Mar 11, 2015, at 2:35 PM, Barry Smith wrote:
>
>
>> On Mar 11, 2015, at 1:50 PM, Manav Bhatia wrote:
>>
>>
>
mpi-lib=
>>
>> I notice you have --with-fortran=0 if you do not want fortran than use
>> --with-fc=0 and do not provide --FC and this may solve the gfortran issue
>>
>> Barry
>>
>>
>>
>>> On Mar 11, 2015, at 1:24 PM, Manav Bhatia wrote:
Greetings!
I have come across the following error while running make check. I am not
sure where to begin to sort this out. Any pointers would be greatly
appreciated.
Talon-login[114] bhatia$ make check
gmake[1]: Entering directory
`/cavs/projects/sams/codes/raptor/petsc/petsc-3.5.3'
Runni
1 - 100 of 130 matches
Mail list logo