[petsc-users] about pclu

2011-04-07 Thread Ryan Yan
Nice Observation. :-) Y As a point of encouragement and appreciation, this is a sign of a much-used product that people are applying to increasingly-sophisticated research. -- next part -- An HTML attachment was scrubbed... URL:

[petsc-users] about pclu

2011-04-07 Thread Ryan Yan
. If a pair of back-substitution and forward-substitution counts 1 MatSolve. Then I think we mean the same thing. Thanks, Yan On Thu, Apr 7, 2011 at 10:08 AM, Jed Brown jed at 59a2.org wrote: On Thu, Apr 7, 2011 at 16:06, Ryan Yan vyan2000 at gmail.com wrote: Hi Jed, How is going? :-) PREONLY maybe

[petsc-users] Snes ex22.c

2010-03-29 Thread Ryan Yan
Dear All, Could someone help to answer a question about snes/ex22.c? I runed the program twice with two different option sets. In the first run, I used: mpirun -np 1 ./ex22 -da_grid_x 10 -snes_monitor this will invoke all the matrix_free_options at line 96. It is shown that on all grid levels

[petsc-users] A Question about Vec

2010-02-04 Thread Ryan Yan
Hi Satish, Thank you very much for the crystal clear explanation. Yan On Thu, Feb 4, 2010 at 12:24 AM, Satish Balay balay at mcs.anl.gov wrote: On Wed, 3 Feb 2010, Ryan Yan wrote: Hi all, Can someone help me to understand the Vec? My question is: in the following piece of code

[petsc-users] A Question about Vec

2010-02-03 Thread Ryan Yan
Hi all, Can someone help me to understand the Vec? My question is: in the following piece of code, will a be changed, if b is changed by the subroutine SNESComputeFunction? I did see that both a and b are both pointers to an object. Vec a = b; Vec c; initalize c; SNESComputeFunction(snes, c,

[petsc-users] How to find a good initial guess for a BVP

2010-02-01 Thread Ryan Yan
/tutorials/ex27.c, namely, multiply a rho(x) term to each of the right hand side of the line p380-384? Or is there invisible barrier that I should beware of. Thank you very much, Yan On Tue, Jan 26, 2010 at 11:27 AM, Ryan Yan vyan2000 at gmail.com wrote: Hi Jed, Thank you very much

[petsc-users] How to find a good initial guess for a BVP

2010-01-26 Thread Ryan Yan
Hi Matt, Thanks a lot for the suggestion. Yan On Tue, Jan 26, 2010 at 5:46 AM, Matthew Knepley knepley at gmail.com wrote: You might try the pseudo-transient continuation code. Matt On Mon, Jan 25, 2010 at 9:03 PM, Ryan Yan vyan2000 at gmail.com wrote: Hi All, Hopefully

[petsc-users] How to find a good initial guess for a BVP

2010-01-26 Thread Ryan Yan
wrote: On Mon, 25 Jan 2010 22:03:57 -0500, Ryan Yan vyan2000 at gmail.com wrote: I am solving a nonlinear BVP(steady-states) extracted from a time-dependent problem by setting d/dt=0. Globalization of steady-state problems is notoriously difficult, it's very likely that you will need

[petsc-users] Is the staggered grid good for SNES? or only for SIMPLE scheme?

2010-01-26 Thread Ryan Yan
Hi All, I am re-thinking my discretization of a problem: is the stagger grid only good for SIMPLE scheme? I am wondering if I am using a stagger grid with FVM to discretize the conservation system(velocity, pressure, internal energy), is there any drawback of using newton's method to solve it,

[petsc-users] Is the staggered grid good for SNES? or only for SIMPLE scheme?

2010-01-26 Thread Ryan Yan
about PDE discretizations for which there is a huge literature. You should talk to a fluid dynamics person about your particular problem. Agreed. Thank you very much for the suggestion. Sorry for this off-topic thread. Yan Barry On Jan 26, 2010, at 4:57 PM, Ryan Yan wrote: Hi All

[petsc-users] How to find a good initial guess for a BVP

2010-01-25 Thread Ryan Yan
Hi All, Hopefully, this is not considered as an off-topic thread. Since I got snes converged reason -6. Can anyone please share some hints on how to find a good inital guess? I am solving a nonlinear BVP(steady-states) extracted from a time-dependent problem by setting d/dt=0. The equation is

[petsc-users] scalar abs()

2010-01-15 Thread Ryan Yan
Hi All, I am solving nonlinear BVP on structure grid using DM. For the variable v, I have the following term included in my residual: abs(v)*v My question is: In DMMGSetSNESLocal(), for the FormFunctionLocal(), at interior node i, What is the right PETSc function to use for the abs in:

[petsc-users] scalar abs()

2010-01-15 Thread Ryan Yan
Thanks a lot, Yan On Fri, Jan 15, 2010 at 2:29 PM, Matthew Knepley knepley at gmail.com wrote: You can also use PetscAbsScalar(). Matt On Fri, Jan 15, 2010 at 1:29 PM, Matthew Knepley knepley at gmail.comwrote: fabs(). Matt On Fri, Jan 15, 2010 at 1:25 PM, Ryan Yan vyan2000

[petsc-users] Snes behavior

2010-01-11 Thread Ryan Yan
. There is a 99% probability this is your problem. If you cannot find the bug then send your function evaluation and how you form the DA to petsc-maint at mcs.anl.gov and we'll find it. Barry On Jan 10, 2010, at 9:13 PM, Ryan Yan wrote: Hi Barry, Here is the result

[petsc-users] Snes behavior

2010-01-11 Thread Ryan Yan
Never mind, I saught boundary conditions in your last email. Thank you very much, Yan On Mon, Jan 11, 2010 at 10:32 AM, Ryan Yan vyan2000 at gmail.com wrote: Hi Barry, This is my case: In 1-d, for the interior pts the stencil width is 1, but for boundary pts the stencil width is 2. Should

[petsc-users] Snes behavior

2010-01-11 Thread Ryan Yan
Thanks a lot for the confirm, Yan On Mon, Jan 11, 2010 at 12:27 PM, Barry Smith bsmith at mcs.anl.gov wrote: On Jan 11, 2010, at 9:32 AM, Ryan Yan wrote: Hi Barry, This is my case: In 1-d, for the interior pts the stencil width is 1, but for boundary pts the stencil width is 2. Should

[petsc-users] Snes behavior

2010-01-10 Thread Ryan Yan
Hi All, I am solving a nonlinear system using snes. The -snes_monitor option has the following output: 0 SNES Function norm 2.640163923729e+09 1 SNES Function norm 1.047643565314e+08 2 SNES Function norm 1.712732074788e+06 3 SNES Function norm 1.002169173269e+04 4 SNES Function norm

[petsc-users] Snes behavior

2010-01-10 Thread Ryan Yan
at 2:55 PM, Ryan Yan vyan2000 at gmail.com wrote: Hi All, I am solving a nonlinear system using snes. The -snes_monitor option has the following output: 0 SNES Function norm 2.640163923729e+09 1 SNES Function norm 1.047643565314e+08 2 SNES Function norm 1.712732074788e+06 3 SNES

[petsc-users] Snes behavior

2010-01-10 Thread Ryan Yan
Hi Matt, Thanks, On Sun, Jan 10, 2010 at 4:34 PM, Matthew Knepley knepley at gmail.com wrote: On Sun, Jan 10, 2010 at 3:28 PM, Ryan Yan vyan2000 at gmail.com wrote: Hi Matt, Thank you very much for the suggestion. I was using DMMGSetSNESLocal(dmmg,FormFunctionLocal,0,ad_FormFunctionLocal

[petsc-users] Snes behavior

2010-01-10 Thread Ryan Yan
^16 drop in the residual norm. It is not realistic to expect to get much more than that for double precision calculations. Perhaps your original F() has some funky scaling of different components that you can fix. Barry On Jan 10, 2010, at 2:55 PM, Ryan Yan wrote: Hi All, I am solving

[petsc-users] Snes behavior

2010-01-10 Thread Ryan Yan
Hi Barry, Please see reply below, On Sun, Jan 10, 2010 at 4:57 PM, Barry Smith bsmith at mcs.anl.gov wrote: On Jan 10, 2010, at 3:52 PM, Ryan Yan wrote: Hi Barry, Yes, exactly. The original multi-components system scale quite unevenly. I will try to rescale it. Could this be helpful

[petsc-users] Snes behavior

2010-01-10 Thread Ryan Yan
they indicate? Thanks a lot, Yan On Sun, Jan 10, 2010 at 5:57 PM, Barry Smith bsmith at mcs.anl.gov wrote: JUST run with -snes_mf_operator and then with -snes_type test NOT together, Barry On Jan 10, 2010, at 4:42 PM, Ryan Yan wrote: Hi Barry, Please see reply below, On Sun, Jan 10

ksp tutorial ex22

2009-12-16 Thread Ryan Yan
what it is trying to do. My BC has du/dx=0 and du/dy = 0 and I believe it's the same as that of ex29.c if I do it in Fortran, is it the same? Thanks again! On Sat, Dec 12, 2009 at 12:25 AM, Ryan Yan vyan2000 at gmail.com wrote: On Fri, Dec 11, 2009 at 1:44 AM, Wee-Beng Tay zonexo

Mesh resolution

2009-12-15 Thread Ryan Yan
Hi All, I was ignoring the importance of fixing the mesh size. For instance, if I want to compare the effect of mesh sequencing on the solver, I will use one level with 256 pt on each direction in 2d, in the first run. My question is, in the second run, how to set up the number of points on the

Mesh resolution

2009-12-15 Thread Ryan Yan
of grids. R Quoting Ryan Yan vyan2000 at gmail.com: Sorry, I forgot to cc to the group. BTW, if this is designed to have only odd number of points on the finer level grid, can anyone provide a hint on the reasoning behind this? Thanks a lot, Yan On Tue, Dec 15, 2009 at 10:09 PM, Ryan Yan

SetSNESLocali

2009-12-14 Thread Ryan Yan
Hi All, I was looking at the snes ex19, and wondering whether there is a maual page for the following two functions. DMMGSetSNESLocali, DMMGSetSNESLocalib, Thanks, Yan -- next part -- An HTML attachment was scrubbed... URL:

SetSNESLocali

2009-12-14 Thread Ryan Yan
Hi Barry, Thanks for letting me know. Yan On Mon, Dec 14, 2009 at 7:22 PM, Barry Smith bsmith at mcs.anl.gov wrote: These are not documented because they are experimental code and not intended to be used. Barry On Dec 14, 2009, at 5:06 PM, Ryan Yan wrote: Hi All, I was looking

KSPPREONLY

2009-12-14 Thread Ryan Yan
Hi All, I have the following output from -snes_view with the default snes setting., but I don't know what the KSPPREONLY does on the coarse grid. Can anyone provide some hints on this? Assuming: A_{coarse} * e_{coarse} =r _{coarse} Thanks a lot, Yan

KSPPREONLY

2009-12-14 Thread Ryan Yan
. Since LU is the preconditioner in this case preonly means it is using LU as a direct solver. On Dec 14, 2009, at 10:09 PM, Ryan Yan wrote: Hi All, I have the following output from -snes_view with the default snes setting., but I don't know what the KSPPREONLY does on the coarse grid. Can

KSPPREONLY

2009-12-14 Thread Ryan Yan
Thanks a lot, Yan On Mon, Dec 14, 2009 at 11:23 PM, Barry Smith bsmith at mcs.anl.gov wrote: Yes On Dec 14, 2009, at 10:19 PM, Ryan Yan wrote: Hi, Barry, Thanks a lot. So this is equivalent to using ksp richardson +pclu with 1 iteration on the coarse grid, right? Yan On Mon, Dec

ksp ex29.c B.C.s and Forcing terms.

2009-12-12 Thread Ryan Yan
have some cell-centered and some vertex centered unknowns (staggered grid), DA does not handle this well, you have to cheat to match up variables on the cells and vertices. Barry Tahar Le 12 d?c. 09 ? 02:28, Barry Smith a ?crit : On Dec 11, 2009, at 7:18 PM, Ryan Yan wrote: Hi

ksp ex29.c B.C.s and Forcing terms.

2009-12-12 Thread Ryan Yan
, 2009 at 5:35 PM, Matthew Knepley knepley at gmail.com wrote: On Sat, Dec 12, 2009 at 4:34 PM, Ryan Yan vyan2000 at gmail.com wrote: Hi Barry, Since the ex32.c has been brought up to make comparison with ex29.c. Can I just get a confirm that, in ex29.c, the instance with Neumann B.C.s

ksp ex29.c B.C.s and Forcing terms.

2009-12-12 Thread Ryan Yan
Hi Matt, Thank you very much for the comment, agreed on 29.c. Yan On Sat, Dec 12, 2009 at 5:47 PM, Matthew Knepley knepley at gmail.com wrote: On Sat, Dec 12, 2009 at 4:44 PM, Ryan Yan vyan2000 at gmail.com wrote: Hi Matt, I am not fixing the potential for Newman constraints, and that's

ksp tutorial ex22

2009-12-11 Thread Ryan Yan
? Or is ex29 a better example, although I need time to digest the C syntax. thanks alot! On Fri, Dec 11, 2009 at 4:14 AM, Ryan Yan vyan2000 at gmail.com wrote: Hi Barry, Thank you very much for the confirm. Yan On Thu, Dec 10, 2009 at 3:12 PM, Barry Smith bsmith at mcs.anl.gov wrote

ksp ex29.c B.C.s and Forcing terms.

2009-12-11 Thread Ryan Yan
Hi All, I am tring to understand the example in ksp tutorials ex29.c http://www.mcs.anl.gov/petsc/petsc-as/snapshots/petsc-current/src/ksp/ksp/examples/tutorials/ex29.c.html For the forcing terms of codes, array[j][i] =

ksp ex29.c B.C.s and Forcing terms.

2009-12-11 Thread Ryan Yan
Hi Matt, Thank you very much for the reply. Now, I got the Neumann part. But I am still a bit confused about the Dirichlet part. Please see the following quote. Yan For the Dirichlet B.C.s, I did not understand the coefficients **http://www.physicsforums.com/showthread.php?t=51412given below.

ksp tutorial ex22

2009-12-10 Thread Ryan Yan
Hi all, I was looking at the ex22 of ksp. If I call: ... ierr = DMMGCreate(PETSC_COMM_WORLD,3,PETSC_NULL,dmmg);CHKERRQ(ierr); ierr = DACreate3d(PETSC_COMM_WORLD,DA_NONPERIODIC,DA_STENCIL_STAR,-3,-3,-3,PETSC_DECIDE,PETSC_DECIDE,PETSC_DECIDE,1,1,0,0,0,da);CHKERRQ(ierr); ... How many grid pts

ksp tutorial ex22

2009-12-10 Thread Ryan Yan
Hi Barry, Thank you very much for the confirm. Yan On Thu, Dec 10, 2009 at 3:12 PM, Barry Smith bsmith at mcs.anl.gov wrote: On Dec 10, 2009, at 2:09 PM, Ryan Yan wrote: Hi all, I was looking at the ex22 of ksp. If I call: ... ierr = DMMGCreate(PETSC_COMM_WORLD,3,PETSC_NULL,dmmg

Line search question

2009-12-06 Thread Ryan Yan
. f_n Barry On Dec 5, 2009, at 10:24 PM, Ryan Yan wrote: Hi All, I am trying to figure out how the line search is actually working in PETSc and I am looking at this link, http://www.mcs.anl.gov/petsc/petsc-as/snapshots/petsc-current/docs/manualpages/SNES/SNESLineSearchGetParams.html F(x

Can I use MatSetBlockSize() for MPIAIJ

2009-11-07 Thread Ryan Yan
Hi All, I have a question as follows: In order to use MatSetValuesBlocked() for a MPIAIJ matrix. I need to call MatSetBlockSize() when I create the matrix. so I did the following. Here the blocksize = 5; Mat *A; MatCreate(MPI_COMM_WORLD,A);

Can I use MatSetBlockSize() for MPIAIJ

2009-11-07 Thread Ryan Yan
Sorry a typo: MatCreate(MPI_COMM_WORLD,*A); On Sat, Nov 7, 2009 at 2:57 PM, Ryan Yan vyan2000 at gmail.com wrote: Hi All, I have a question as follows: In order to use MatSetValuesBlocked() for a MPIAIJ matrix. I need to call MatSetBlockSize() when I create the matrix. so I did

Can I use MatSetBlockSize() for MPIAIJ

2009-11-07 Thread Ryan Yan
preallocating it). On Sat, Nov 7, 2009 at 3:12 PM, Jed Brown jed at 59a2.org wrote: Ryan Yan wrote: Hi All, I have a question as follows: In order to use MatSetValuesBlocked() for a MPIAIJ matrix. I need to call MatSetBlockSize() when I create the matrix. Call MatSetBlockSize

Can I use MatSetBlockSize() for MPIAIJ

2009-11-07 Thread Ryan Yan
It works. Thanks agian. Yan On Sat, Nov 7, 2009 at 3:17 PM, Ryan Yan vyan2000 at gmail.com wrote: Hi Jed, Thanks, So the following is very confusing: http://www.mcs.anl.gov/petsc/petsc-as/snapshots/petsc-current/docs/manualpages/Mat/MatSetValuesBlocked.html Notes The m and n count

ell1 norm convergence test

2009-09-22 Thread Ryan Yan
21, 2009, at 2:04 PM, Ryan Yan wrote: Hi Barry, Thanks for the suggestion. I am using FGMRES as the krylov solver. Is there a direct access to the residual vector for FGMRES. I guess the answer is yes, since that's the Krylov method which supports right preconditioning and provides the true

ell1 norm convergence test

2009-09-21 Thread Ryan Yan
Hi All, The following question is only for test and comparison reason. Is there a command line option to set up using 1-Norm(sum of absolute value of residuals) as convergence monitor and test. Alternatively, if I can get the residual r out at the end of each iteration, then it is going to be

ell1 norm convergence test

2009-09-21 Thread Ryan Yan
Hi Matt, Thanks for the pointer. Yan On Mon, Sep 21, 2009 at 2:40 PM, Matthew Knepley knepley at gmail.com wrote: You can use KSPBuildResidual(). Matt On Mon, Sep 21, 2009 at 12:44 PM, Ryan Yan vyan2000 at gmail.com wrote: Hi All, The following question is only for test

ell1 norm convergence test

2009-09-21 Thread Ryan Yan
src/ksp/ksp/impls/cg/cgctx.h Barry On Sep 21, 2009, at 12:44 PM, Ryan Yan wrote: Hi All, The following question is only for test and comparison reason. Is there a command line option to set up using 1-Norm(sum of absolute value of residuals) as convergence monitor and test

ell1 norm convergence test

2009-09-21 Thread Ryan Yan
Sorry, FGMRES does not need to compute residual expilictly. Please forget about what I just asked. Yan On Mon, Sep 21, 2009 at 3:04 PM, Ryan Yan vyan2000 at gmail.com wrote: Hi Barry, Thanks for the suggestion. I am using FGMRES as the krylov solver. Is there a direct access

ell1 norm convergence test

2009-09-21 Thread Ryan Yan
you can reformulate fgmres to give you back the residual efficiently. I have been told that QMR has a natural 1-norm formulation, but I have never seen it. Matt Barry On Sep 21, 2009, at 2:04 PM, Ryan Yan wrote: Hi Barry, Thanks for the suggestion. I am using FGMRES as the krylov

sparsity pattern setup

2009-09-21 Thread Ryan Yan
. The first time count the number of blocks per row, then preallocate then read through the ASCII file again reading and setting the values. This will be very fast. Barry- Hide quoted text - On Sep 20, 2009, at 10:20 AM, Ryan Yan wrote: Hi All, I have a large size application. Mesh size is 3

BAIJ or AIJ

2009-09-20 Thread Ryan Yan
Hi All, I have a large size application. Mesh size is 3 nodes, with dof 25 on each vertex. And it's 3d unstructured, Tet, and Hex mesh. In the following I will denote blksize=25 I am testing how to build up a PETSc matrix object quick and fast. The data I have is Block Compressed Sparse

BAIJ or AIJ

2009-09-20 Thread Ryan Yan
[u, v, w, p, a]^5, here 5 means 5 physical phase, for instance, bubble1, liquid1, bubble2, liquid2,solid1. u, v, w, p, a from conservation of the physics. Thanks, Yan On Sun, Sep 20, 2009 at 11:20 AM, Ryan Yan vyan2000 at gmail.com wrote: Hi All, I have a large size application. Mesh size

BAIJ or AIJ

2009-09-20 Thread Ryan Yan
the ASCII file again reading and setting the values. This will be very fast. Barry On Sep 20, 2009, at 10:20 AM, Ryan Yan wrote: Hi All, I have a large size application. Mesh size is 3 nodes, with dof 25 on each vertex. And it's 3d unstructured, Tet, and Hex mesh. In the following I

Out of Memory Error.

2009-09-19 Thread Ryan Yan
Hi All, My application code is reading PETSc binary files to obtain the information about a linear system and then solve it in parallel. The code works well for median size problem. Now, I am testing a largest case requested by our custom on *one* processor. I got the following errors. It looks

Out of Memory Error.

2009-09-19 Thread Ryan Yan
Matt, thanks for the confirmation. Yan On Sat, Sep 19, 2009 at 3:24 PM, Matthew Knepley knepley at gmail.com wrote: On Sat, Sep 19, 2009 at 2:12 PM, Ryan Yan vyan2000 at gmail.com wrote: Hi All, My application code is reading PETSc binary files to obtain the information about a linear

a question about tolerance

2009-09-16 Thread Ryan Yan
On Tue, Sep 15, 2009 at 8:29 PM, Matthew Knepley knepley at gmail.com wrote: On Tue, Sep 15, 2009 at 6:04 PM, Ryan Yan vyan2000 at gmail.com wrote: Thanks Jed. And in the term ||Ae||/||Ax||, PETSc impilictly assume that we use zero as initial guess and here the x really means exact

a question about tolerance

2009-09-16 Thread Ryan Yan
Hi Barry, Thank you very much for the explanation. It is good to know there are more options to start with. Yan On Tue, Sep 15, 2009 at 8:32 PM, Barry Smith bsmith at mcs.anl.gov wrote: On Sep 15, 2009, at 6:04 PM, Ryan Yan wrote: Thanks Jed. And in the term ||Ae||/||Ax||, PETSc

a question about tolerance

2009-09-15 Thread Ryan Yan
Hi All, I have a question about -ksp_rtol. when I run my application with -ksp_rtol 1e-2, I got the convergence history as the follows. 0 KSP preconditioned resid norm 2.129970351489e+03 true resid norm 1.040507012955e-02 ||Ae||/||Ax|| 1.e+00 1 KSP preconditioned resid norm

a question about tolerance

2009-09-15 Thread Ryan Yan
Thanks Jed. And in the term ||Ae||/||Ax||, PETSc impilictly assume that we use zero as initial guess and here the x really means exact solution, right? Yan On Tue, Sep 15, 2009 at 6:41 PM, Jed Brown jed at 59a2.org wrote: Ryan Yan wrote: But can you say a little more about what happened

How to set the ksp true residual tolerance on command line

2009-07-28 Thread Ryan Yan
Hi all, Is there any way to set a true residual tolerance on command line. -ksp_atol is for preconditioned residual norm only. Thanks, Yan -- next part -- An HTML attachment was scrubbed... URL:

How to set the ksp true residual tolerance on command line

2009-07-28 Thread Ryan Yan
cg -ksp_norm_type unpreconditioned For CG many people prefer the energy norm which you can access with -ksp_norm_type natural -ksp_view should always show which it is using Barry On Jul 28, 2009, at 8:15 PM, Ryan Yan wrote: Hi all, Is there any way to set a true residual tolerance

PETSC debugger

2009-07-20 Thread Ryan Yan
Thank you very much, Jed. I will try your suggestion. Yan On Mon, Jul 20, 2009 at 5:47 AM, Jed Brown jed at 59a2.org wrote: Ryan Yan wrote: Only debugging one processes is a way to go for my current bug(s). There is another option for debugging multiple processes using screen instead

PETSC debugger

2009-07-20 Thread Ryan Yan
jed at 59a2.org wrote: Ryan Yan wrote: Only debugging one processes is a way to go for my current bug(s). There is another option for debugging multiple processes using screen instead of X. For the sake of cleanliness, start a new terminal and open a special screen session for debugging

PETSC debugger

2009-07-20 Thread Ryan Yan
Thanks, Jed. Please see reply below. On Mon, Jul 20, 2009 at 3:17 PM, Jed Brown jed at 59a2.org wrote: Ryan Yan wrote: My X server set up may be messed up somehow. Same error as before. Using screen bypasses X, so that seems an unlikely candidate. After I creat a new session using

PETSC debugger

2009-07-19 Thread Ryan Yan
Hi All, I am tring to use the PETSc runtime option -start_in_debugger. However, when I attach the debugger at run time to each process, there are error messages and I only get one gdb window(Am I suppose to get as many as the number of the processes?) vyan2000 at

PETSC debugger

2009-07-19 Thread Ryan Yan
server and restarting? Barry On Jul 18, 2009, at 11:50 PM, Ryan Yan wrote: Thank you very much, Barry. After I use the vyan2000-linux:0.0, I got errors without any gdb window. vyan2000 at vyan2000-linux:~/local/PPETSc/petsc-2.3.3-p15/src/ksp/ksp/examples/tutorials/ttt2$ mpirun -np 2

PETSC debugger

2009-07-19 Thread Ryan Yan
ServerArgsLocal=-nolisten tcp in kdm, in the kdmrc file (on my system located at /etc/kde/kdm/kdmrc). After restarting kdm, I get all windows of gdb coming up. Regards, Berend. Ryan Yan wrote: I do not have acess to linux right now, I will check it as the first thing tomorrow. Yan On Sun, Jul

PETSC debugger

2009-07-19 Thread Ryan Yan
On Sun, Jul 19, 2009 at 2:52 PM, Berend van Wachem b.van-wachem at imperial.ac.uk wrote: Dear Ryan, I am not a Gnome user, but a colleague of mine suggested: For Gnome you should edit the file /etc/gdm/gdm.conf and change the settings: DisallowTCP=false Regards, Berend. Ryan Yan wrote

about src/mat/examples/tutorials/ex5.c.html

2009-07-12 Thread Ryan Yan
http://www.mcs.anl.gov/petsc/petsc-2/snapshots/petsc-current/src/mat/examples/tutorials/ex5.c.html Hi All, I am tring to read through an example about PetscBinaryRead. It looks like the matrix is reading from a CRS matrix object descriptor fd1, or fd2. I have difficulty of understand the line

about src/mat/examples/tutorials/ex5.c.html

2009-07-12 Thread Ryan Yan
the diagonal and off-diagonal parts of the matrix. That is all determined when the binary file is read in. That's exactly what I get confused with. Thank you very much, Yan Barry On Jul 12, 2009, at 3:30 PM, Ryan Yan wrote: http://www.mcs.anl.gov/petsc/petsc-2/snapshots/petsc

PCFIELDSPLIT

2009-07-06 Thread Ryan Yan
Hi, All, I am reading a large Block Compressed Row Storage PETSc from an application into PETSc binary files. And I use matload to load this PETSc binar matrix as mpiaij. Since the matrix is resulting from a finite volume discretization with degree of freedom 5 at each cell center, what I am

Petsc configure error

2009-06-24 Thread Ryan Yan
Hi all, I got configuration errors, when I trying to built PETSC with Tau. Basically, I followed the instruction on the installation webpage of PETSc. In the attached file, please find the configure log. I do built TAU and PDT seperately, and TAU with mpi and PDT. If any more information is

Petsc configure error

2009-06-24 Thread Ryan Yan
analysis on a solver. Do you have any suggestion on doing performance analysis for PETSc solvers? One comment though.. If you have tau built with mpi - you should use that mpi wrappers with tau and not use --download-mpich. [but this is also likely broken] Satish On Wed, 24 Jun 2009, Ryan Yan

About the -pc_type tfs

2009-05-15 Thread Ryan Yan
Hi all, I am tring to use the tfs preconditioner to solve a large sparse mpiaij matrix. 1 It works very well with a small matrix 45*45(Actually a 9*9 block matrix with blocksize 5) on 2 processors; Out put is as follows: 0 KSP preconditioned resid norm

MPIAIJ and MatSetValuesBlocked

2009-05-04 Thread Ryan Yan
switch between AIJ and BAIJ for testing. Barry On May 1, 2009, at 5:04 PM, Ryan Yan wrote: Hi, all, I am using MPIAIJ for my matrix A, but when I call the function MatSetValuesBlocked, I got the error: PetscPrintf(PETSC_COMM_WORLD, breakpoint 1\n); ierr

MPIAIJ and MatSetValuesBlocked

2009-05-04 Thread Ryan Yan
2009, Ryan Yan wrote: Hi Barry, My matrix is read from files stroing a matrix in the Block CRS format. So a natural way to create the matrix is MPIBAIJ. However, if I want to use MatSetValuesBlocked() for the newly created MPIBAIJ, I still need to load a tempary arrary(from Block CRS

MPIAIJ and MatSetValuesBlocked

2009-05-01 Thread Ryan Yan
Hi, all, I am using MPIAIJ for my matrix A, but when I call the function MatSetValuesBlocked, I got the error: PetscPrintf(PETSC_COMM_WORLD, breakpoint 1\n); ierr = MatSetValuesBlocked(A,1,irow,1,(col_ind+icol),temp_vector,INSERT_VALUES); PetscPrintf(PETSC_COMM_WORLD, breakpoint