Error when using MKL 10.0.5.025

2008-12-01 Thread Ben Tay
-shared=0 --with-shared=0 --with-blas-lapack-dir=/opt/intel/cmkl/10.0.5.025/lib/em64t However, if I use back MKL 8.1.1, with similar command, then there's no such problem. Hope you can help. Thanks! -- Yours sincerely, Ben Tay

Using ex2f to determine server's MPI performance

2008-07-02 Thread Ben Tay
Hi, I'm thinking of using the example code ex2f to determine my school server's MPI performance. Since my own code uses a 1200x1080 grid, I let m and n in ex2f.F be equal to 1200 and 1080 respectively. I ran the code on 4 processors and found that it's taking a very long time to complete for

Analysis of performance of parallel code as processors increase

2008-06-10 Thread Ben Tay
from 4 to 8 processes, this is why you do not see such a great speedup. Barry On Jun 6, 2008, at 8:07 PM, Ben Tay wrote: Hi, I have coded in parallel using PETSc and Hypre. I found that going from 1 to 4 processors gives an almost 4 times increase. However from 4 to 8 processors only

Error using BoomerAMG with eqns

2008-06-10 Thread Ben Tay
Ya Thank you Barry. I also realised it. Barry Smith wrote: You use KSPGetPC(ksp_uv,pc_uv,ierr) but call PCSetType(pc,'hypre',ierr) this is why you should ALWAYS, always use implicit none Barry On Jun 9, 2008, at 9:46 PM, Ben Tay wrote: Hi, I tried to use BoomerAMG

Analysis of performance of parallel code as processors increase

2008-06-07 Thread Ben Tay
Hi, I have coded in parallel using PETSc and Hypre. I found that going from 1 to 4 processors gives an almost 4 times increase. However from 4 to 8 processors only increase performance by 1.2-1.5 instead of 2. Is the slowdown due to the size of the matrix being not large enough? Currently I

Solving 2 eqns at the same time in PETSc

2008-05-31 Thread Ben Tay
Hi, (I sent this email a while ago but I use a different email address. Not sure if it got through since it's not registered in the server list. Sorry if it was resent.) I obtain 2 linear eqns (u and v velocity) from the momentum eqn in my CFD code. Instead of solving eqn 1 in parallel, and

Comparing matrices between 2 different codes and viewing of matrix

2008-05-28 Thread Ben Tay
) call PetscViewerDestroy(viewer,ierr) On May 27, 2008, at 5:57 AM, Ben Tay wrote: Hi Barry, Thanks for pointing out. However, I only got a 0 byte file after adding the include statement. I am programming in parallel and my matrix is created using MatCreateMPIAIJ. Did I missed out some

Using MAT_NO_NEW_NONZERO_LOCATIONS and MAT_SYMMETRIC give error

2008-05-28 Thread Ben Tay
Hi, I read in the manual that I can use either call MatSetOption(A_mat_uv,MAT_NO_NEW_NONZERO_LOCATIONS,PETSC_TRUE,ierr) or call MatSetOption(A_mat,MAT_SYMMETRIC,PETSC_TRUE,ierr). When I use MAT_NO_NEW_NONZERO_LOCATIONS for the matrix formed by my momentum eqn, I get the error on my home

Comparing matrices between 2 different codes and viewing of matrix

2008-05-27 Thread Ben Tay
this stuff. On May 25, 2008, at 5:43 AM, Ben Tay wrote: Hi, I have an old serial code and a newer parallel code. The new parallel code is converted from the old serial code. However, due to numerous changes, the answers from the new code now differs from the old one after the 1st step. What

Comparing matrices between 2 different codes and viewing of matrix

2008-05-25 Thread Ben Tay
Hi, I have an old serial code and a newer parallel code. The new parallel code is converted from the old serial code. However, due to numerous changes, the answers from the new code now differs from the old one after the 1st step. What is the best way to compare the matrices from the 2

How to efficiently change just the diagonal vector in a matrix at every time step

2008-05-10 Thread Ben Tay
as the matrix, not A. I don't know if this approach is efficient or not. Can anybody comment? Thanks, Sean On May 9, 2008, at 2:33 PM, Ben Tay wrote: Hi, I have a matrix and I inserted all the relevant values during the 1st step. I'll then solve it. For the subsequent steps, I only need

Using PETSc libraries with MS Compute cluster and MS MPI

2008-04-24 Thread Ben Tay
Hi, I'm trying to run my mpi code on the MS Compute cluster which my school just installed. Unfortunately, it failed without giving any error msg. I am using just a test example ex2f. I read in the MS website that there is no need to use MS MPI to compile the code or library. Anyway, I also

Slow speed after changing from serial to parallel (with ex2f.F)

2008-04-20 Thread Ben Tay
. Sorry abt that. Thank you very much. Satish Balay wrote: On Sat, 19 Apr 2008, Ben Tay wrote: Btw, I'm not able to try the latest mpich2 because I do not have the administrator rights. I was told that some special configuration is required. You don't need admin rights

Slow speed after changing from serial to parallel

2008-04-18 Thread Ben Tay
An HTML attachment was scrubbed... URL: http://lists.mcs.anl.gov/pipermail/petsc-users/attachments/20080418/ca9caf8e/attachment.htm

Slow speed after changing from serial to parallel

2008-04-16 Thread Ben Tay
a huge number of off-process values in the matrix (see MatAssemblyBegin). Is this true? I would reorganize this part. Matt On Tue, Apr 15, 2008 at 10:33 AM, Ben Tay zonexo at gmail.com wrote: Hi, I have converted the poisson eqn part of the CFD code to parallel. The grid size

Slow speed after changing from serial to parallel

2008-04-16 Thread Ben Tay
. Barry On Apr 15, 2008, at 10:56 AM, Ben Tay wrote: Oh sorry here's the whole information. I'm using 2 processors currently: *** WIDEN YOUR WINDOW TO 120

Slow speed after changing from serial to parallel

2008-04-16 Thread Ben Tay
Hi, I was initially using LU and Hypre to solve my serial code. I switched to the default GMRES when I converted the parallel code. I've now redo the test using KSPBCGS and also Hypre BommerAMG. Seems like MatAssemblyBegin, VecAYPX, VecScatterEnd (in bold) are the problems. What should I be

Slow speed after changing from serial to parallel (with ex2f.F)

2008-04-16 Thread Ben Tay
An HTML attachment was scrubbed... URL: http://lists.mcs.anl.gov/pipermail/petsc-users/attachments/20080416/0f3ee54b/attachment.htm

Slow speed after changing from serial to parallel

2008-04-14 Thread Ben Tay
, 2008 at 4:12 AM, Ben Tay zonexo at gmail.com wrote: Hi, I've a serial 2D CFD code. As my grid size requirement increases, the simulation takes longer. Also, memory requirement becomes a problem. Grid size 've reached 1200x1200. Going higher is not possible due to memory problem. I tried

Slow speed after changing from serial to parallel

2008-04-14 Thread Ben Tay
structures (like Mat and Vec) using a binary viewer. Then run in parallel with the same code, which will output the same structures. Take the two files and write a small verification code that loads both versions and calls MatEqual and VecEqual. Matt On Mon, Apr 14, 2008 at 5:49 AM, Ben Tay

Slow speed after changing from serial to parallel

2008-04-13 Thread Ben Tay
Hi, I've a serial 2D CFD code. As my grid size requirement increases, the simulation takes longer. Also, memory requirement becomes a problem. Grid size 've reached 1200x1200. Going higher is not possible due to memory problem. I tried to convert my code to a parallel one, following the examples

Can't run ./configure at installation

2008-03-26 Thread Ben Tay
and it worked last time. I wonder what other additions must I install? Thank you. Matthew Knepley wrote: On Mon, Mar 24, 2008 at 8:57 PM, Ben Tay zonexo at gmail.com wrote: Hmm, Tried to reinstall Python but it still can't work. Any other idea? In order to install you must get

Linking problems with ifort and visual studio 2003

2008-03-24 Thread Ben Tay
_GLOBAL_DATA_mp_ALLO_VAR Looks like this code is compiled by Compaq Fortran compiler - and not intel fortran. Can you verify? Satish On Sun, 23 Mar 2008, Ben Tay wrote: Hi, I've successfully compiled the library of PETSc. The examples also worked (I tested ex1f). However in the IDE

Linking problems with ifort and visual studio 2003

2008-03-23 Thread Ben Tay
Hi, I've successfully compiled the library of PETSc. The examples also worked (I tested ex1f). However in the IDE of visual studio 2003, I can't seem to link, although compiling the individual files were fine. The errors are: global.obj error LNK2019: unresolved external symbol

how to inverse a sparse matrix in Petsc?

2008-02-07 Thread Ben Tay
Ya, Lisandro, it's my mistake. It is indeed SPD. Thank you for your reminder! Lisandro Dalcin wrote: On 2/6/08, Ben Tay zonexo at gmail.com wrote: Because my grid's are non-uniform in both x,y directions. Shouldn't that result in a non-symmetric matrix? But I think it's still PD

how to inverse a sparse matrix in Petsc?

2008-02-06 Thread Ben Tay
wonder if that is true? If that's the case, then it's not possible for me to use it, although it's a constant coefficient Poisson operator with Neumann or Dirchelet boundary conditions. thank you. Barry Smith wrote: On Feb 5, 2008, at 8:04 PM, Ben Tay wrote: Hi Lisandro, I'm using

how to inverse a sparse matrix in Petsc?

2008-02-06 Thread Ben Tay
, Ben Tay wrote: Thank you Barry for your enlightenment. I'll just continue to use BoomerAMG for the poisson eqn. I'll also check up on FFTW. Last time, I recalled that there seemed to be some restrictions for FFT on solving poisson eqn. It seems that the grids must be constant in at least 1

Estimating PETSc performance using SuperPI's results

2007-12-05 Thread Ben Tay
Hi, I'm thinking of ways to estimate and compare the performance of PETSc on different CPUs. I think it will also enable one to make the wise choice of whether to upgrade or not. Of cos, the best way is to run your own code on the new machine to see how much increase there is. However, most

Dual core performance estimate

2007-11-18 Thread Ben Tay
Hi, someone was talking abt core 2 duo performance on os x in some previous email. it seems that due to memory issues, it's not possible to get 2x the performance. there's also some mention of amd vs intel dual core. for computation using PETSc, is there any reason to buy one instead of the

Is this the correct way to use MatGetRow? Something wrong here

2007-08-27 Thread Ben Tay
Thanks Zhang Hong! I've got it working. Hong Zhang wrote: See ~petsc/src/mat/examples/tests/ex58f.F on how to use MatGetRow() from Fortran. Hong On Mon, 27 Aug 2007, Ben Tay wrote: Hi, I'm trying to view a particular row of a matrix. This 's what I do in my loops: real(8

Routine to convert matrix to CSR format

2007-08-25 Thread Ben Tay
Hi, May I know if there's a routine which can convert a matrix initially created using MatCreateSeqAIJ to compressed row format (CSR) ? Then I would like to view it in my visual fortran debugger. In other words, the matrix is in standard array format, not Mat. Thanks

Best way to find empty row in matrix

2007-08-25 Thread Ben Tay
Hi, when KSPSolve is called, I got the following errors: Detected zero pivot in LU factorization Empty row in matrix! There's definitely some errors in the code, but I just can't detect it. PETSc does not tell me which row. How can I find out? Btw, I'm working in visual fortran Thank you

Error during example compilation of test examples

2007-08-25 Thread Ben Tay
-2.3.3-p4/src/ksp/ksp/examples/tutorials $ On Thu, 23 Aug 2007, Ben Tay wrote: Hi, I got this error while trying to compile the test example in src/ksp/ksp/example/tutorials/ex1f /codes/petsc-2.3.3-p4/bin/win32fe/win32fe f90 -c -threads -debug:full -fpp:-m -I/codes/petsc-2.3.3-p4

Error during example compilation of test examples

2007-08-24 Thread Ben Tay
Hi, I got this error while trying to compile the test example in src/ksp/ksp/example/tutorials/ex1f /codes/petsc-2.3.3-p4/bin/win32fe/win32fe f90 -c -threads -debug:full -fpp:-m -I/codes/petsc-2.3.3-p4 -I/codes/petsc-2.3.3-p4/bmake/win32 -I/codes/petsc-2.3.3 -p4/include

Using ML and options

2007-08-17 Thread Ben Tay
it lower? Thank you. Hong Zhang wrote: On Thu, 16 Aug 2007, Ben Tay wrote: Btw, is the file to download ftp://ftp.mcs.anl.gov/pub/petsc/externalpackages/ml-5.0.tar.gz? Yes. You can simply use '--download-ml=1' during configuration. Run your program with '-help' to see all

Using ML and options

2007-08-17 Thread Ben Tay
also get the error msg: *ML*WRN* This function has been compiled without the configure *ML*WRN* option --with-ml_metis *ML*WRN* I will put all the nodes in the same aggregate, this time... *ML*WRN* (file ./Coarsen/ml_agg_METIS.c, line 954) Thanks Barry Smith wrote: On Fri, 17 Aug 2007, Ben Tay

Using -pctype mg -pcmgtype PC_MG_MULTIPLICATIVE

2007-08-16 Thread Ben Tay
Hi, I found that there's a multigrid option in the manual which can be used by adding -pctype mg -pcmgtype PC_MG_MULTIPLICATIVE. However, it seems that I am actually just using LU since with or without this option, I got exactly the same answer. Am I using multigrid the wrong way? Thanks

Using -pctype mg -pcmgtype PC_MG_MULTIPLICATIVE

2007-08-16 Thread Ben Tay
. Or if you have a structured grid, consider using DMMG. Thanks, Matt On 8/15/07, Ben Tay zonexo at gmail.com wrote: Hi, I found that there's a multigrid option in the manual which can be used by adding -pctype mg -pcmgtype PC_MG_MULTIPLICATIVE. However, it seems that I am

Using -pctype mg -pcmgtype PC_MG_MULTIPLICATIVE

2007-08-16 Thread Ben Tay
using DMMG. Thanks, Matt On 8/15/07, Ben Tay zonexo at gmail.com wrote: Hi, I found that there's a multigrid option in the manual which can be used by adding -pctype mg -pcmgtype PC_MG_MULTIPLICATIVE. However, it seems that I am actually just using LU since with or without

Error when solving eqns with PETSc

2007-08-15 Thread Ben Tay
to the constructor are using 0-offset numbering? I suspect that it would be 1-offset for both ia_spar and ja_spar which would cause problems. Matt On 8/14/07, Ben Tay zonexo at gmail.com wrote: Hi, I am currently using the following way to solve my poisson eqn in global.F (global variables

Error when solving eqns with PETSc

2007-08-15 Thread Ben Tay
Well, I did call MatDestroy, but that's at the very last step when everything's over. It's ok. I'll give to figure out where the problem occurs. Thanks Matthew Knepley wrote: On 8/14/07, Ben Tay zonexo at gmail.com wrote: Oh, I will check up valgrind since I've not used it b4

Error when solving eqns with PETSc

2007-08-14 Thread Ben Tay
Hi, I am currently using the following way to solve my poisson eqn in global.F (global variables) implicit none save MatA_mat Vecxx,b_rhs KSP ksp PCpc PCType ptype KSPTypeksptype then they are initialized call PetscInitialize(PETSC_NULL_CHARACTER,ierr) call

Programming in *.f90 free format with PETSc

2007-08-10 Thread Ben Tay
can comiile locally. Satish On Thu, 9 Aug 2007, Ben Tay wrote: Hi Satish, I am sorry if I have made you angry. I may have missed out some important points which you tried to highlight. I was converting several of my .F fixed format files to .f90 (or .F90) free format and some files

Programming in *.f90 free format with PETSc

2007-08-10 Thread Ben Tay
2007, Ben Tay wrote: Thank you Satish. I followed what you recommended exactly and used sed -e 's/^C/\!/g' With the new mpif.h, I got the following error: global.i90 d:\cygwin\codes\MPICH\SDK\include\mpif.h(174) : Error: DEC$ ATTRIBUTES DLLIMPORT attribute can appear only

Programming in *.f90 free format with PETSc

2007-08-09 Thread Ben Tay
Hi, when I changed my global.F to global.f90, I was told that PETSC_COMM_SELF, PETSC_NULL_INTEGER and PETSC_NULL_CHARACTER does not have a type. I declare MPI_Comm PETSC_COMM_SELF and it works So, what about the other 2? You mention to use integer NORM_MAX parameter NORM_MAX=3 What values

Conversion matrix from Ellpack-Itpack to CSR to PETSc format

2007-08-09 Thread Ben Tay
Hi, My original matrix is stored in Ellpack-Itpack format, which is used by the NSPCG solver. I have problems when I insert the values of the matrix into a PETSc matrix. I guessed I made some mistakes but I can't find where during debugging. So I intent to just convert from the Ellpack-Itpack

Programming in *.f90 free format with PETSc

2007-08-09 Thread Ben Tay
a type, and must have an explicit type. [PETSC_NULL_CHARACTER]. Same for PETSC_NULL_INTEGER and PETSC_COMM_SELF. It was ok when I'm programming in fixed format. Thanks Satish Balay wrote: On Thu, 9 Aug 2007, Ben Tay wrote: Hi, when I changed my global.F to global.f90, Any

Programming in *.f90 free format with PETSc

2007-08-09 Thread Ben Tay
, everything's ok. You can give it a try too. Lastly, I understand that you have been helping a lot of users and there's really a lot of stupid users around (I know I'm one of them ;-) ). Thank you for your patience. Satish Balay wrote: On Thu, 9 Aug 2007, Ben Tay wrote: Hi, Guess I'm

Programming in *.f90 free format with PETSc

2007-08-08 Thread Ben Tay
variable declarations (in case you use a PETSc type variable). Good Luck, Paul Ben Tay wrote: Hi, I can compile and run with visual fortran by putting all the declarations inside a subroutine e.g. module ada ... subroutine ddd #define PETSC_AVOID_DECLARATIONS #include

Programming in *.f90 free format with PETSc

2007-08-07 Thread Ben Tay
be removed from here.. other includes #undef PETSC_AVOID_DECLARATIONS moudle foobar other module stuff end module Satish On Mon, 6 Aug 2007, Ben Tay wrote: Hi, I tried to use #define PETSC_AVOID_DECLARATIONS #include include/finclude/petsc.h other includes #undef

Comparing between a PETSc matrix and a standard fortran array in compressed row format

2007-08-06 Thread Ben Tay
right? Any other suggestion? Thanks. Barry Smith wrote: Run with -ksp_type gmres -pc_type lu -ksp_monitor_true_residual -ksp_truemonitor At the bad iteration verify if the true residual is very small. Barry On Sun, 5 Aug 2007, Ben Tay wrote: Well, ya, they're the same

Programming in *.f90 free format with PETSc

2007-08-06 Thread Ben Tay
Hi, I've no problem writing out codes in fortran fixed format with PETSc. However, is it possible to do it in fortran free format as well? I'm using visual fortran and there's error. original : test.F module global_data implicit none save #include include/finclude/petsc.h #include

Programming in *.f90 free format with PETSc

2007-08-06 Thread Ben Tay
subroutine xyz() use foobar implicit none #include include/finclude/petsc.h other includes code end subroutine Satish On Mon, 6 Aug 2007, Ben Tay wrote: Hi, I've no problem writing out codes in fortran fixed format with PETSc. However, is it possible to do it in fortran free

Problem with using ADD_VALUES

2007-08-06 Thread Ben Tay
Hi, I am trying to insert values into a matrix. I used to use INSERT_VALUES with MatSetValues or MatSetValue. However, since I need to add values to the same II,JJ location more than 1 time, I have to use ADD_VALUES with MatSetValues. However I got this error message: Object is in wrong

Comparing between a PETSc matrix and a standard fortran array in compressed row format

2007-08-04 Thread Ben Tay
converging. Run with -ksp_converged_reason and or -ksp_monitor. My guess is that the matrix is becoming very ill-conditioned so the solvers with the default options are failing. Barry On Fri, 3 Aug 2007, Ben Tay wrote: Hi, I used 2 packages to solve my poisson eqn, which is part

Comparing between a PETSc matrix and a standard fortran array in compressed row format

2007-08-04 Thread Ben Tay
2007, Ben Tay wrote: Hi, I realised that the matrix storage format of NSPCG is actually ITPACK storage format. Anyway, I tried to insert the values into a PETSc matrix, use MatAXPY with the scalar a = -1 and then use MatNorm on the output matrix. Using NORM_1, NORM_FROBENIUS

Comparing between a PETSc matrix and a standard fortran array in compressed row format

2007-08-03 Thread Ben Tay
Hi, I used 2 packages to solve my poisson eqn, which is part of my NS unsteady solver. One is the NSPCG solver package which uses the compressed row format to store the A matrix. The other is PETSc. I found that using both solvers gave me similar answers for a number of time step. However,

Fixing values in a poisson eqn

2007-08-02 Thread Ben Tay
Hi, I am trying to solve a pressure poisson eqn resulting from the NS eqn. How can I fixed the pressure at some nodes while solving the poisson eqn? I tried to make the coefficient of the diagonal location of the node very big e.g. 1e100. I also use call

How is the sys of linear eqns solved using PETSc in this application?

2007-07-31 Thread Ben Tay
Hi, I'm formulating a NS solver which computes the flow past an airfoil. The airfoil has a c-grid and it overlaps with the background cartesian grid. In other words, it is a chimera or overset grid application. The boundary cells of the c-grid are connected to the cartesian grid thru

KSP/PC choice

2007-07-25 Thread Ben Tay
Hi, I am also trying to solve the NS eqns in 2d, finite volume mtd, using fractional step formulation. I am currently using KSPBCGS and PCILU to solve the momentum eqn matrix and HYPRE's AMG and the default ksptype to solve the poisson eqn. Do you ppl think this is a good choice? Or is there

KSPSetTolerances and processors size

2007-06-19 Thread Ben Tay
Is the matrix symmetric? Do you expect/want it to be symmetric? Barry On Mon, 18 Jun 2007, Ben Tay wrote: Oh btw, here's the output when KSPSetTolerances = 1.0e-5. 1: 0 KSP preconditioned resid norm 5.509130713952e+01 true resid norm 3.411770553001e+01 ||Ae||/||Ax

KSPSetTolerances and processors size

2007-06-18 Thread Ben Tay
= 1.0e-8 Thanks again On 6/17/07, Barry Smith bsmith at mcs.anl.gov wrote: Ben, On Sat, 16 Jun 2007, Ben Tay wrote: Hi, I am trying to use PETSc to solve my poisson eqn. In the past, when I'm not using MPI, I set KSPSetTolerances to 1.0e-5. This seems to be good enuff. Now, I'm

Worthwhile to use PETSc to solve lots of small matrices?

2007-06-17 Thread Ben Tay
Hi, I am doing CFD and at each time step, I need to interpolate values at different points. I'm doing bi-quadratic interpolation and hence to get each interpolated value, I need to solve a 9x9 matrices. There's about 100+ pts and hence 100+ 9x9 matrices to solve per time step. I'm wondering if

How to zero all values on a particular row?

2007-06-11 Thread Ben Tay
Smith bsmith at mcs.anl.gov wrote: On Sun, 10 Jun 2007, Ben Tay wrote: Hi, I need to insert values into a matrix and then solve this poisson eqn as part of my cfd code. For efficiency sake, I simply use do j=1,size_y do i=1,size_x matsetvalue end do end do

How to zero all values on a particular row?

2007-06-10 Thread Ben Tay
Hi, I need to insert values into a matrix and then solve this poisson eqn as part of my cfd code. For efficiency sake, I simply use do j=1,size_y do i=1,size_x matsetvalue end do end do to insert values into all the cells Then for specific cells, I need to enter some other

Fortran could not successfully link C++ objects problem

2007-06-07 Thread Ben Tay
Hi, I got this error during configure: Fortran could not successfully link C++ objects My command is : ./config/configure.py --with-vendor-compilers=intel --with-blas-lapack-dir=/usr/local/intel/mkl721cluster/ --with-debugging=0 --download-hypre=1 --with-x=0

30mins lecture tutorial on using PETSc on laplace eqns

2007-06-04 Thread Ben Tay
Hi, I found this link when doing a PETSc search.It is 30mins online lecture which introduces and explains the use of PETSc on solving the laplace eqn. Hope it's useful to new users http://infostream.rus.uni-stuttgart.de/lec/307/537/real/ -- next part -- An HTML attachment

libc.lib error when linking test examples

2007-06-02 Thread Ben Tay
to do this is to manualy edit bmake/$PETSC_ARCH/petscconf and change PCC_LINKER to use 'win32fe f90' Satish On Fri, 1 Jun 2007, Ben Tay wrote: Hi, I'm using ms vc++ and vf in windows xp. I tried to compile PETSc 2.3.3p0 . Running configure has no problem. Compiling seems ok

libc.lib error when linking test examples

2007-06-01 Thread Ben Tay
Hi, I'm using ms vc++ and vf in windows xp. I tried to compile PETSc 2.3.3p0. Running configure has no problem. Compiling seems ok but in the last part when it tried to test examples, the error is --Error detected during compile or link!--- See

Can't read MPIRUN_HOST

2007-05-22 Thread Ben Tay
Hi, I tried to compile PETSc and there's no problem. I also used the *--with-batch=1 *option since my server is using a job scheduler. There's no shared library and I'm installing hypre too. However, when after sending the job for ex1f, I got the error msg: Can't read MPIRUN_HOST. So what's

Can't read MPIRUN_HOST

2007-05-22 Thread Ben Tay
, Ben Tay wrote: Hi, I tried to compile PETSc and there's no problem. I also used the *--with-batch=1 *option since my server is using a job scheduler. There's no shared library and I'm installing hypre too. However, when after sending the job for ex1f, I got the error msg: Can't

Can't read MPIRUN_HOST

2007-05-22 Thread Ben Tay
It's ex1f. Thanks On 5/22/07, Satish Balay balay at mcs.anl.gov wrote: Is this a PETSc example? Which one is it? Satish On Tue, 22 May 2007, Ben Tay wrote: ok. I sorted out that problem. Now I got this error: *** glibc detected *** double free or corruption (!prev

Calling hypre

2007-05-22 Thread Ben Tay
: call PCSetType(pc,'hypre',ierr) call PCHYPRESetType(pc,'boomeramg',ierr) Satish On Tue, 22 May 2007, Ben Tay wrote: Hi, presently I am using ./a.out -pc_type hypre -pc_hypre_type boomeramg to use hypre. However, I have 2 matrix to solve and now I only want one of them to use

Can't read MPIRUN_HOST

2007-05-22 Thread Ben Tay
] Satish On Tue, 22 May 2007, Ben Tay wrote: It's ex1f. Thanks On 5/22/07, Satish Balay balay at mcs.anl.gov wrote: Is this a PETSc example? Which one is it? Satish On Tue, 22 May 2007, Ben Tay wrote: ok. I sorted out that problem. Now I got this error

Calling hypre

2007-05-22 Thread Ben Tay
Ops how careless. Thanks again. On 5/22/07, Barry Smith bsmith at mcs.anl.gov wrote: pcsettype On Tue, 22 May 2007, Ben Tay wrote: Sorry I got this error during linking: petsc_sub.o(.text+0x20c): In function `petsc_sub_mp_petsc_solver_pois_': /nfs/home/enduser/g0306332/ns2d_c

Calling hypre

2007-05-22 Thread Ben Tay
have used : call PCHYPRESetType(pc,'boomeramg',ierr) call PCSetType(pc,'hypre',ierr) I changed the 2 order but it still can't work. Thanks again On 5/22/07, Ben Tay zonexo at gmail.com wrote: Ops how careless. Thanks again. On 5/22/07, Barry Smith bsmith at mcs.anl.gov wrote

Calling hypre

2007-05-22 Thread Ben Tay
? Thanks On 5/22/07, Satish Balay balay at mcs.anl.gov wrote: you are probably doing this inside a loop. check the code. satish On Tue, 22 May 2007, Ben Tay wrote: Sorry to trouble you ppl again. The 1st step worked but subsequently I got the error msg

lgcc_s not found error

2007-05-08 Thread Ben Tay
Hi, I've built static PETSc library with mpi/hypre w/o problems. The test e.g. also worked. When I tried to built my own a.out, using -static (fortran), the error is lgcc_s not found. removing it in the make file resulted in a lot of error for mpich2. btw, i do not have root access. the

Deleting lapack*, blas* etc

2007-04-16 Thread Ben Tay
Hi, I've finished compiling PETSc and it use the fblaslapack external package. May I know if I can delete the directories blas1-3, lapack1-6 and the lapack-extra1-4? Thanks -- next part -- An HTML attachment was scrubbed... URL:

Option with HYPRE and KSP

2007-04-09 Thread Ben Tay
Ok thank you very much On 4/9/07, Barry Smith bsmith at mcs.anl.gov wrote: On Mon, 9 Apr 2007, Ben Tay wrote: Hi, I am solving a poisson eqn and using hypre as a preconditioner has greatly increased the speed. I am trying to do some more tuning and I have some questions: 1

Copying shared lib files

2007-03-13 Thread Ben Tay
Hi, I've compiled PETSc on my school's server and I wonder if I can simply copy the compiled shared library/include files to my home comp's linux. Both uses redhat. Is there anything else I have to take care? Thank you -- next part -- An HTML attachment was scrubbed...

How to configure Compaq visual fortran for PETSc w/o mpi

2007-03-05 Thread Ben Tay
Hi, I've managed to use PETSc in Compaq visual fortran using --download-blas-lapack=1 with mpi installed. Now I tried to recompile PETSc with --with-mpi=0. I then tried to remove mpich.lib from the linking options. compiling is ok but during linking, I got these error msg: linking...

How to configure Compaq visual fortran for PETSc w/o mpi

2007-03-05 Thread Ben Tay
is a stub library for one process) libmpiuni.lib Barry On Mon, 5 Mar 2007, Ben Tay wrote: Hi, I've managed to use PETSc in Compaq visual fortran using --download-blas-lapack=1 with mpi installed. Now I tried to recompile PETSc with --with-mpi=0. I then tried to remove mpich.lib from

Deleting hypre files other than the library

2007-03-03 Thread Ben Tay
Hi, I've used --download-hypre=1 to integrate hypre into PETSc. I've found the hypre directory in externalpackages. hypre takes up about 136mb. Can I delete the files other than the library files (such as src) after I've compile them? Thanks alot! -- next part -- An HTML

Problem with using --download-f-blas-lapack=1 in windows

2007-03-03 Thread Ben Tay
Hi, I tried to compile PETSc with compaq visual fortran in cygwin. My command is $ ./config/configure.py --with-cc='win32fe cl' --with-fc='win32fe f90' --download-f-blas-lapack=1 --with-f90-interface=win32 --with-x=0 --with-mpi-dir=/cygdrive/c/program\ files/MPICH/SDK I then got this error

Using Compaq visual fortran with PETSc and not installing Intel MKL/MPICH

2007-02-22 Thread Ben Tay
Hi, I have been using PETSc with visual fortran/intel mkl/mpich installed. This has the same configuration as the configuration file .dsw supplied by PETSc. However, now using another of my school's computer, MKL and MPICH are not installed. Is there anyway I can still use compaq visual fortran

understanding the output from -info

2007-02-13 Thread Ben Tay
problem with hypre - remove externalpackages/hypre-1.11.1b and retry. Satish On Mon, 12 Feb 2007, Ben Tay wrote: Hi, I tried to compile PETSc again and using --download-hypre=1. My command given is ./config/configure.py --with-vendor-compilers=intel --with-blas-lapack-dir=/lsftmp

External software help

2007-02-12 Thread Ben Tay
Hi, I'm trying to experiment with using external solvers. I have some questions: 1. Is there any difference in speed with calling the external software from PETSc or directly using them? 2. I tried to install MUMPS using --download-mumps. I was prompted to include --with-scalapack. After

External software help

2007-02-12 Thread Ben Tay
. Thank you. On 2/12/07, Satish Balay balay at mcs.anl.gov wrote: On Mon, 12 Feb 2007, Ben Tay wrote: Hi, I'm trying to experiment with using external solvers. I have some questions: 1. Is there any difference in speed with calling the external software from PETSc or directly using

understanding the output from -info

2007-02-11 Thread Ben Tay
eqn... wonder if hypre/BoomerAMG etc would help... On 2/11/07, Lisandro Dalcin dalcinl at gmail.com wrote: On 2/10/07, Ben Tay zonexo at gmail.com wrote: In other words, for my CFD code, it is not possible to parallelize it effectively because the problem is too small? Is these true

understanding the output from -info

2007-02-10 Thread Ben Tay
Ya, that's the mistake. I changed part of the code resulting in PetscFinalize not being called. Here's the output: -- PETSc Performance Summary: -- /home/enduser/g0306332/ns2d/a.out on a linux-mpi named

understanding the output from -info

2007-02-10 Thread Ben Tay
--with-mpi-dir=/opt/mpich/myrinet/intel/ - On 2/10/07, Ben Tay zonexo at gmail.com wrote: Hi, I tried to use ex2f.F as a test code. I've changed the number n,m from 3 to 500 each. I ran the code using 1 processor and then with 4 processor. I then repeat

understanding the output from -info

2007-02-09 Thread Ben Tay
Hi, I've tried to use log_summary but nothing came out? Did I miss out something? It worked when I used -info... On 2/9/07, Lisandro Dalcin dalcinl at gmail.com wrote: On 2/8/07, Ben Tay zonexo at gmail.com wrote: i'm trying to solve my cfd code using PETSc in parallel. Besides the linear

understanding the output from -info

2007-02-09 Thread Ben Tay
: Impossible, please check the spelling, and make sure your command line was not truncated. Matt On 2/9/07, Ben Tay zonexo at gmail.com wrote: ya, i did use -log_summary. but no output. On 2/9/07, Barry Smith bsmith at mcs.anl.gov wrote: -log_summary On Fri, 9 Feb

understanding the output from -info

2007-02-08 Thread Ben Tay
Hi, i'm trying to solve my cfd code using PETSc in parallel. Besides the linear eqns for PETSc, other parts of the code has also been parallelized using MPI. however i find that the parallel version of the code running on 4 processors is even slower than the sequential version. in order to find

Using PETSc in structured c-grid for CFD and multigrid

2007-02-01 Thread Ben Tay
Hi, somone suggested that I treat that face as a dirichlet boundary condition. after 1 or a few iterations, the face value will be updated and it will be repeated until covergerence. I wonder if that is possible as well? It'll make the job much easier, although the iteration may take longer...

Difference between debugging and optimized version of PETSc

2007-01-30 Thread Ben Tay
Hi, May I know what's the difference between the optimized and debugging version? Have the optimization flags such as -O3 been used in the compilcation of the libraries for the optimized one? Whereas for the debugging version, there is no optimization by the compiler? If my program works fine

Difference between debugging and optimized version of PETSc

2007-01-30 Thread Ben Tay
to functions etc in the debug version. Barry On Mon, 29 Jan 2007, Matthew Knepley wrote: On 1/29/07, Ben Tay zonexo at gmail.com wrote: Hi, May I know what's the difference between the optimized and debugging version? Have the optimization flags such as -O3 been used

Lapack/blas and Gotoblas

2007-01-27 Thread Ben Tay
. Is there some other directory where they are usually install? I'm wondering if I can use lapack + gotoblas together? I tried to specify the libraries but ./configure failed. Thank you. On 1/27/07, Satish Balay balay at mcs.anl.gov wrote: On Sat, 27 Jan 2007, Ben Tay wrote: My school's server has

Using PETSc in structured c-grid for CFD and multigrid

2007-01-26 Thread Ben Tay
Hi, I was discussing with another user in another forum (cfd-online.com) about using PETSc in my cfd code. I am now using KSP to solve my momentum and poisson eqn by inserting values into the matrix. I was told that using PETSc this way is only for unstructured grids. It is very inefficient and

  1   2   >