[petsc-dev] easyinstall for petsc4py

2010-08-05 Thread Barry Smith
On Aug 5, 2010, at 9:59 AM, Matthew Knepley wrote: On Thu, Aug 5, 2010 at 9:56 AM, Lisandro Dalcin dalcinl at gmail.com wrote: On 5 August 2010 00:39, Lisandro Dalcin dalcinl at gmail.com wrote: On 4 August 2010 12:44, Barry Smith bsmith at mcs.anl.gov wrote: Lisandro, We would

[petsc-dev] something to consider adding to PETSc

2010-08-12 Thread Barry Smith
From: Bas Fagginger Auer b.o.faggingera...@uu.nl Date: Wed, 4 Aug 2010 15:02:44 +0200 Subject: Mondriaan 3.0 : Sparse Matrix Partitioning Package Mondriaan 3.0: Sparse matrix partitioning package We would like to announce the availability of version 3.0 of the Mondriaan package. Mondriaan can

[petsc-dev] something to consider adding to PETSc

2010-08-12 Thread Barry Smith
orderings might be a big win for LU. Matt On Thu, Aug 12, 2010 at 1:38 PM, Barry Smith bsmith at mcs.anl.gov wrote: From: Bas Fagginger Auer B.O.FaggingerAuer at uu.nl Date: Wed, 4 Aug 2010 15:02:44 +0200 Subject: Mondriaan 3.0 : Sparse Matrix Partitioning Package Mondriaan 3.0: Sparse

[petsc-dev] using consistant username for commits

2010-08-19 Thread Barry Smith
:Jed Brown jed at 59A2.org thanks, Satish --- asterix:/home/balay/tmp/petsc-devhg log | grep 'user:' | head -100 | sort | uniq user:balay at mcs.anl.gov user:Barry Smith bsmith at mcs.anl.gov user:Dmitry Karpeev karpeev at mcs.anl.gov user

[petsc-dev] Stop breaking my build

2010-08-19 Thread Barry Smith
Shri, Since this is development code that only you are working on you can protect its use by putting a #requirespackage 'PETSC_USE_DVI' in the makefile in that directory and if you register the method in SNESRegisterAll() then protect it with #if defined(PETSC_USE_DVI) then define

[petsc-dev] proceedings on preliminary work on PETSc with GPUs

2010-08-19 Thread Barry Smith
Folks, Please find attached an easy proceedings paper on the preliminary work Victor did this summer on getting PETSc to run on GPUs. We would appreciate any comments or corrections to Barry, Victor and Matt at the cc list above. Thanks! Barry

[petsc-dev] proceedings on preliminary work on PETSc with GPUs

2010-08-19 Thread Barry Smith
Here is the paper. Barry On Aug 19, 2010, at 4:14 PM, Barry Smith wrote: Folks, Please find attached an easy proceedings paper on the preliminary work Victor did this summer on getting PETSc to run on GPUs. We would appreciate any comments or corrections to Barry

[petsc-dev] Stop breaking my build

2010-08-19 Thread Barry Smith
variables with real upper and lower bounds don't make sense to me and i don't know of any actual problems which have or need complex bounds. - Barry Smith bsmith at mcs.anl.gov wrote: Shri, Since this is development code that only you are working on you can protect its use by putting

[petsc-dev] a few issues with current CUDA code for Mat.

2010-08-20 Thread Barry Smith
On Aug 19, 2010, at 6:59 PM, Lisandro Dalcin wrote: I bet all involved people is aware of most of this issues, but just in case. * MatAssemblyEnd_SeqAIJCUDA: What about mode=MAT_FLUSH_ASSEMBLY? What's the point of coping to the GPU? Fixed. * MatAssemblyEnd_SeqAIJCUDA: the 'tempvec'

[petsc-dev] Problem with conjugate gradient solver

2010-08-23 Thread Barry Smith
On Aug 23, 2010, at 2:31 PM, Anush Krishnan wrote: Hi, I was trying to compile and run the example file $PETSC_DIR/src/ksp/pc/examples/tutorials/ex3.c, which demonstrates PETSc's preconditioned conjugate gradient solver for a system of linear equations. After compiling, running make

[petsc-dev] Problem with conjugate gradient solver

2010-08-24 Thread Barry Smith
Please send your configure.log to petsc-maint On Aug 23, 2010, at 11:17 PM, Anush Krishnan anush at bu.edu wrote: Message: 6 Date: Mon, 23 Aug 2010 18:40:34 -0500 From: Barry Smith bsmith at mcs.anl.gov Subject: Re: [petsc-dev] Problem with conjugate gradient solver To: For users

[petsc-dev] Problem with conjugate gradient solver

2010-08-24 Thread Barry Smith
1. 1. I am cc:iing Victor who supposedly wrote the original example. Barry Attached is the matrix saved with -mat_view_matlab On Aug 23, 2010, at 11:17 PM, Anush Krishnan wrote: Message: 6 Date: Mon, 23 Aug 2010 18:40:34 -0500 From: Barry Smith bsmith at mcs.anl.gov

[petsc-dev] fix needed for PETSc's use of _mm_prefetch

2010-08-26 Thread Barry Smith
and not require adding to configure. Barry On Aug 26, 2010, at 4:26 AM, Jed Brown wrote: On Wed, 25 Aug 2010 18:19:50 -0500, Barry Smith bsmith at mcs.anl.gov wrote: libfast in: /users/nyevik/MANUALBUILD/petsc-3.1-p4/src/mat/impls/aij/seq inode.c: In function 'PetscErrorCode

[petsc-dev] change to DAVecGetArrayF90()

2010-08-26 Thread Barry Smith
I have made a slight change to DAVecGetArrayF90() the arrays are now indexed from xs:xs+xl-1 instead of xs+1:xs+xl Barry

[petsc-dev] What's the point of D(A/M)GetGlobalVector?

2010-08-27 Thread Barry Smith
On Aug 27, 2010, at 8:13 AM, Aron Ahmadia wrote: Not to mention the various Get routines that are actually used to create things, such as DAGetMatrix. Still, the idea of a pool of work vectors makes sense, I was just trying to wrap my head around the actual use for those routines.

[petsc-dev] What's the point of D(A/M)GetGlobalVector?

2010-08-27 Thread Barry Smith
On Aug 27, 2010, at 8:47 AM, Jed Brown wrote: On Fri, 27 Aug 2010 08:27:22 -0500, Barry Smith bsmith at mcs.anl.gov wrote: It would actually be nice if we made DACreateGlobal/LocalVector() so light-weight that it could be used for work vectors (instead of needing a different set of light

[petsc-dev] When __FUNCT__ is wrong

2010-08-27 Thread Barry Smith
Jed, You are certainly welcome to add it. Barry On Aug 27, 2010, at 11:59 AM, Jed Brown wrote: C99 mandates __func__, but unfortunately C++ and earlier C standards mandate no such thing. Even so, most compilers support __FUNCTION__, __PRETTY_FUNCTION__ (distinct in C++), or

[petsc-dev] What's the point of D(A/M)GetGlobalVector?

2010-08-27 Thread Barry Smith
Hmmm, petscda.h:EXTERN PetscErrorCode PETSCDM_DLLEXPORT DMGetColoring(DM,ISColoringType,const MatType,ISColoring*); petscda.h:EXTERN PetscErrorCode PETSCDM_DLLEXPORT DMGetMatrix(DM, const MatType,Mat*); petscda.h:EXTERN PetscErrorCode PETSCDM_DLLEXPORT

[petsc-dev] Problem with petsc-dev

2010-08-27 Thread Barry Smith
You can run, for example, src/snes/examples/tutorials ex19 with the options -pc_type jacobi -dmmg_nlevels 5 -da_vec_type cuda -da_mat_type aijcuda and run without those last two options to NOT use the GPU and compare the results with -log_summary. We'd be interesting in seeing those

[petsc-dev] Problem with petsc-dev

2010-08-27 Thread Barry Smith
-bounces at mcs.anl.gov [mailto:petsc-dev-bounces at mcs.anl.gov] On Behalf Of Barry Smith Sent: Friday, August 27, 2010 1:13 PM To: For users of the development version of PETSc Subject: Re: [petsc-dev] Problem with petsc-dev You can run, for example, src/snes/examples/tutorials ex19

[petsc-dev] [GPU] Performance on Fermi

2010-08-27 Thread Barry Smith
PETSc-dev folks, Please prepend all messages to petsc-dev that involve GPUs with [GPU] so they can be easily filtered. Keita, To run src/ksp/ksp/examples/tutorials/ex2.c with CUDA you need the flag -vec_type cuda Note also that this example is fine for simple ONE

[petsc-dev] [GPU] Performance on Fermi

2010-08-27 Thread Barry Smith
] On Behalf Of Barry Smith Sent: Friday, August 27, 2010 2:15 PM To: For users of the development version of PETSc Subject: [petsc-dev] [GPU] Performance on Fermi PETSc-dev folks, Please prepend all messages to petsc-dev that involve GPUs with [GPU] so they can be easily filtered

[petsc-dev] [GPU] Performance on Fermi

2010-08-27 Thread Barry Smith
On Aug 27, 2010, at 4:34 PM, Keita Teranishi wrote: Jed, I usually manually edit petscconf.h and petscvariables to change the installation configurations for Cray XT/XE. The problem is configure script of PETSc picks up wrong variables and #define macros because the OS and library

[petsc-dev] When __FUNCT__ is wrong

2010-08-28 Thread Barry Smith
: On 27 August 2010 17:54, Jed Brown jed at 59a2.org wrote: On Fri, 27 Aug 2010 12:45:46 -0500, Barry Smith bsmith at mcs.anl.gov wrote: Jed, You are certainly welcome to add it. fdbdc93647ff This just writes inconsistencies via PetscErrorPrintf, only in debug mode. I think

[petsc-dev] When __FUNCT__ is wrong

2010-08-28 Thread Barry Smith
On Aug 28, 2010, at 6:25 PM, Satish Balay wrote: On Fri, 27 Aug 2010, Jed Brown wrote: On Fri, 27 Aug 2010 12:45:46 -0500, Barry Smith bsmith at mcs.anl.gov wrote: Jed, You are certainly welcome to add it. fdbdc93647ff This just writes inconsistencies via PetscErrorPrintf

[petsc-dev] When __FUNCT__ is wrong

2010-08-28 Thread Barry Smith
On Aug 28, 2010, at 7:57 PM, Satish Balay wrote: The addition in my sugestion was to have a configure option to enable-disable PetscCheck__FUNCT__() It is fine to have that configure option. My concern is the default, if we default off then no one will remember to turn it on and

[petsc-dev] Use of the DISPLAY environment variable

2010-08-29 Thread Barry Smith
On Aug 29, 2010, at 2:45 PM, Jed Brown wrote: PETSc uses the -display option differently from the DISPLAY environment variable. In particular, it prepends the hostname when DISPLAY starts with :. ierr = PetscOptionsGetString(PETSC_NULL,-display,PetscDisplay,256,flag);CHKERRQ(ierr);

[petsc-dev] [GPU] Performance of ex19

2010-08-31 Thread Barry Smith
Please run with the options ./ex19 -da_vec_type seqcuda -da_mat_type seqaijcuda -pc_type none -dmmg_nlevels 1 -da_grid_x 100 -da_grid_y 100 -log_summary -mat_no_inode -preload off -cuda_synchronize On Aug 31, 2010, at 11:45 AM, Keita Teranishi wrote: Hi PETSc Developer team, I have

[petsc-dev] multiple VecGetArray

2010-08-31 Thread Barry Smith
On Aug 31, 2010, at 1:07 PM, Jed Brown wrote: On Tue, 31 Aug 2010 11:21:02 -0300, Lisandro Dalcin dalcinl at gmail.com wrote: Calling VecGetArray multiple times on the same vec seems to work (at least for native vectors). However, in VecSeq impl there is code to prevent such usage. What's

[petsc-dev] [GPU] Performance of ex19

2010-08-31 Thread Barry Smith
0.0e+00 0.0e+00 0.0e+00 0 0 0 0 0 0 0 0 0 0 2940 From: petsc-dev-bounces at mcs.anl.gov [mailto:petsc-dev-bounces at mcs.anl.gov] On Behalf Of Barry Smith Sent

[petsc-dev] [GPU] Performance of ex19

2010-08-31 Thread Barry Smith
? Thanks, Keita Teranishi Scientific Library Group Cray, Inc. keita at cray.com From: petsc-dev-bounces at mcs.anl.gov [mailto:petsc-dev-bounces at mcs.anl.gov] On Behalf Of Barry Smith Sent: Tuesday, August 31, 2010 1:38

[petsc-dev] [GPU] Performance of ex19

2010-08-31 Thread Barry Smith
Keita Teranishi Scientific Library Group Cray, Inc. keita at cray.com From: petsc-dev-bounces at mcs.anl.gov [mailto:petsc-dev-bounces at mcs.anl.gov] On Behalf Of Barry Smith Sent: Tuesday, August 31, 2010 2:03 PM

[petsc-dev] [GPU] Performance of ex19

2010-08-31 Thread Barry Smith
On Aug 31, 2010, at 3:36 PM, Matthew Knepley wrote: On Tue, Aug 31, 2010 at 7:17 PM, Barry Smith bsmith at mcs.anl.gov wrote: On Aug 31, 2010, at 3:14 PM, Keita Teranishi wrote: Does this PETSc use timers from CUDA? No, didn't know there were timers in CUDA. Yes, I use them when

Should BuildSystem download updated external packages when they are out of date?

2009-10-02 Thread Barry Smith
On Oct 2, 2009, at 9:38 AM, Matthew Knepley wrote: On Fri, Oct 2, 2009 at 9:11 AM, Richard Tran Mills rmills at climate.ornl.gov wrote: BuildSystem Folks (Matt, mainly), This is not really a problem for me since I know about this behavior already, but I note that it can cause

anyone breaking things in dense matrices

2009-10-05 Thread Barry Smith
Anybody touch the dense matrices recently to cause these problems? testexamples_C in: /Users/barrysmith/Src/petsc-dev/src/mat/examples/ tests 4,5c4,5 Norm of error for LU 1.e-12 Norm of error for LU 1.e-12 --- Norm of error for LU 10.4403 Norm of error for LU 10.4403 Possible

bug in tfs preconditioner

2009-10-07 Thread Barry Smith
On Oct 7, 2009, at 9:34 AM, Stephan Kramer wrote: think I found a nasty bug in the tfs preconditioner/solver. The first symptons were MPI complaints about corrupted messages in MPI_WAIT on line 1552 of ksp/pc/impls/tfs/gs.c (the file is the same in petsc-dev and 3.0.0). Valgrind

bug in tfs preconditioner

2009-10-07 Thread Barry Smith
On Oct 7, 2009, at 12:50 PM, Jed Brown wrote: On Wed, Oct 7, 2009 at 19:39, Barry Smith bsmith at mcs.anl.gov wrote: I don't think that it is the TFS solver itself that significantly improved. I think it is the new/different algorithms they use in Nek that are better. Ah, thanks

OBJSC = ${SOURCEC:.c=.o}

2009-10-07 Thread Barry Smith
I assume this is completely portable since it is in a few of the makefiles? Barry

one of the most inane things I've seen in PETSc in a long time

2009-10-08 Thread Barry Smith
In my arch-gnu/include/petscconf.h #ifndef PETSC_ARCH_NAME #define PETSC_ARCH_NAME arch-gnu #endif #ifndef PETSC_ARCH #define PETSC_ARCH darwin9 #endif Meanwhile in all the makefiles PETSC_ARCH is arch-gnu I am endeavoring to fix this, but it might break something for a while.

Subsecond sleep

2009-10-16 Thread Barry Smith
It is fine with me to switch the infrastructure to use a PetscReal instead of integer Barry On Oct 16, 2009, at 5:02 AM, Jed Brown wrote: I sometimes want to slow down animation with a small problem size and -draw_pause is generally does what I want, but it can only take integer

most efficient way to use local CSR matrix?

2009-10-20 Thread Barry Smith
Here's the deal. In parallel PETSc does not use a single CSR matrix on each process to hold the MPIAIJ matrix. Hence if you store the matrix on a process as a single CSR matrix then it has to be copied into the PETSc datastructure. MatMPIAIJSetPreallocationCSR() does the copy very

most efficient way to use local CSR matrix?

2009-10-21 Thread Barry Smith
nonzero structure stays the same then yes you need call MatMPIAIJSetPreallocationCSR() only once and use the MatSetValues() calls each Newton step to update the nonzeros. Barry Chris On Oct 20, 2009, at 8:32 PM, Barry Smith wrote: Here's the deal. In parallel PETSc does not use

person who wrote PetscRandomGetValueReal() PetscRandomGetValueImaginary()

2009-10-23 Thread Barry Smith
PetscRandomGetValueReal() and PetscRandomGetValueImaginary() have no mention in their manual pages what they do? Do they return random numbers with a zero imaginary part and a zero real part respectively? Manual page does not see. Also PetscRandomGetValue() does not have .seealso to these

person who wrote PetscRandomGetValueReal() PetscRandomGetValueImaginary()

2009-10-23 Thread Barry Smith
get home on Sunday. Matt On Fri, Oct 23, 2009 at 2:07 PM, Barry Smith bsmith at mcs.anl.gov wrote: PetscRandomGetValueReal() and PetscRandomGetValueImaginary() have no mention in their manual pages what they do? Do they return random numbers with a zero imaginary part and a zero

person who wrote PetscRandomGetValueReal() PetscRandomGetValueImaginary()

2009-10-23 Thread Barry Smith
On Oct 23, 2009, at 2:33 PM, Matthew Knepley wrote: On Fri, Oct 23, 2009 at 2:31 PM, Barry Smith bsmith at mcs.anl.gov wrote: I thought I was working on builder.py? Crude, yes, but the way I want it :-). Were you adding code to builder.py? Yep. I am all for this. However, two

PetscRandomGetValue(), PetscRandomGetValueReal(), PetscRandomGetValueImaginary()

2009-10-26 Thread Barry Smith
There is a lack of symmetry in the meaning of PetscRandomGetValueReal() and PetscRandomGetValueImaginary(). The real returns a PetscReal with a random value in it. The imaginary returns a complex number with zero real part and some imaginary part. I have changed

ideas needed on organizing output of PETSc nightly tests

2009-10-26 Thread Barry Smith
The raw output PETSc's nightly test runs are now finally available online at, see the bottom of http://www.mcs.anl.gov/petsc/petsc-as/developers/index.html for access location. What we need is ideas (and python scripts that implement these ideas) for displaying the information in

changes for PetscMap

2009-10-27 Thread Barry Smith
PetscMap is a strange beast in PETSc. 1) it is not a PetscObject (that is it has no PETSc header) 2) it is used as a PetscMap* instead of PetscMap like most objects 3) it does not have a PetscMapCreate() instead it has a PetscMapInitialize() which is like a create except it does not malloc

Move src/sys/viewerimpl.h to include/private ?

2009-10-28 Thread Barry Smith
It can be moved over. Barry On Oct 28, 2009, at 12:32 PM, Jed Brown wrote: I don't think external projects should have to include ../src/ whatever because this doesn't work if PETSc is installed and it's a screwy API (even if most users don't see it). Any objections to this?

ML symbols in petscksp.so

2009-10-28 Thread Barry Smith
We do do this for Mac (libpetsc*.dylib) and I think it mostly works. But I am not aware of anyone doing this intentionally for PETSc on Linux (though I think it is a good idea if it can be done). Bartry On Oct 28, 2009, at 4:27 PM, Matthew Knepley wrote: On Wed, Oct 28, 2009 at

ML symbols in petscksp.so

2009-10-28 Thread Barry Smith
On Oct 28, 2009, at 4:37 PM, Jed Brown wrote: Barry Smith wrote: We do do this for Mac (libpetsc*.dylib) and I think it mostly works. But I am not aware of anyone doing this intentionally for PETSc on Linux (though I think it is a good idea if it can be done). It has been working

remove 'x11' test from 'make test'

2009-10-28 Thread Barry Smith
On my Mac bsmith-laptop:~/Src/petsc-dev] barrysmith% echo $DISPLAY /tmp/launch-r289TD/:0 I don't seem to have a problem with X when I change my IP address. I carry my laptop around open it and use X and it pretty much always works. Barry On Oct 28, 2009, at 8:02 PM, Satish Balay

remove 'x11' test from 'make test'

2009-10-28 Thread Barry Smith
/msg00073.html Satish On Wed, 28 Oct 2009, Barry Smith wrote: On my Mac bsmith-laptop:~/Src/petsc-dev] barrysmith% echo $DISPLAY /tmp/launch-r289TD/:0 I don't seem to have a problem with X when I change my IP address. I carry my laptop around open it and use X and it pretty much always

changes for PetscMap

2009-10-29 Thread Barry Smith
at gmail.com wrote: I wanted that 10 years ago. Matt On Tue, Oct 27, 2009 at 4:37 PM, Barry Smith bsmith at mcs.anl.gov wrote: PetscMap is a strange beast in PETSc. 1) it is not a PetscObject (that is it has no PETSc header) 2) it is used as a PetscMap* instead of PetscMap like most

most efficient way to use local CSR matrix?

2009-10-29 Thread Barry Smith
counts to allocate storage in PETSC matrices, just don't underestimate. Mark On Oct 21, 2009, at 9:16 AM, Barry Smith wrote: On Oct 20, 2009, at 10:13 PM, Chris Kees wrote: Thanks. Just to make sure I'm following, when I create the matrix I do: MatCreate(PETSC_COMM_WORLD,self-m

ML symbols in petscksp.so

2009-10-29 Thread Barry Smith
On Oct 29, 2009, at 3:52 PM, Lisandro Dalcin wrote: On Thu, Oct 29, 2009 at 4:45 PM, Jed Brown jed at 59a2.org wrote: I realize that the real problem here was OpenCV's libml and the fact that linkers don't resolve symbols by starting with the most recent -L path [*], but we should at

most efficient way to use local CSR matrix?

2009-10-29 Thread Barry Smith
3.936838941525e-01 true resid norm 1.050257318153e+01 ||Ae||/||Ax|| 9.881970495395e-01 2 KSP preconditioned resid norm 7.332823321496e-14 true resid norm 2.408053447453e-13 ||Ae||/||Ax|| 2.265760276816e-14 On Oct 29, 2009, at 3:56 PM, Barry Smith wrote: Hmm, this should not happen. The matrix

who broke PCFieldSplit code in petsc-dev?????????

2009-11-11 Thread Barry Smith
See for example http://ftp.mcs.anl.gov/pub/petsc/nightlylogs/examples_arch-linux-gcc-pgf90_grind.log search for PCSetUp_FieldSplit(). Please fix ASAP. Thanks. Barry And remember before pushing you should run make alltests to make sure you haven't introduced problems.

who broke PCFieldSplit code in petsc-dev?????????

2009-11-11 Thread Barry Smith
? It bombs in MatGetSubMatrix(), and this had an API change. The last change in fieldsplit.c is in July, by Jed. BTW, the #arg is wrong, it should be #5... Matt On Wed, Nov 11, 2009 at 5:16 PM, Barry Smith bsmith at mcs.anl.gov wrote: See for example

-malign-double

2009-11-11 Thread Barry Smith
Satish, gcc supports the option -malign-double on some systems. Please add it to the flags that configure checks for c and c++ and have it added if it exists. Thanks Barry

who broke PCFieldSplit code in petsc-dev?????????

2009-11-12 Thread Barry Smith
Great, thanks, Barry On Nov 11, 2009, at 9:14 PM, Satish Balay wrote: On Wed, 11 Nov 2009, Barry Smith wrote: If we were smart we would keep the results of each nights nightly builds and then we could easily check what DAY things broke. Satish please have it save the old days

-malign-double

2009-11-13 Thread Barry Smith
BlueGene doesn't like 4 byte aligned doubles and sends a bus error after a certain number are generated, Thus I was motivated to make PETSc a bit clearer on that. On Nov 12, 2009, at 9:29 AM, Lisandro Dalcin wrote: On Wed, Nov 11, 2009 at 11:02 PM, Barry Smith bsmith at mcs.anl.gov wrote

-malign-double

2009-11-14 Thread Barry Smith
On Nov 14, 2009, at 11:28 AM, Jed Brown wrote: Barry Smith wrote: Good point, I have removed it. I put it in because I wanted an easy way to test that PETSc double arrays are always 8 byte aligned (and the unaligned struct values were giving me lots of false alarms). A related

-malign-double

2009-11-14 Thread Barry Smith
On Nov 14, 2009, at 4:01 PM, Lisandro Dalcin wrote: On Fri, Nov 13, 2009 at 11:09 PM, Barry Smith bsmith at mcs.anl.gov wrote: Good point, I have removed it. I put it in because I wanted an easy way to test that PETSc double arrays are always 8 byte aligned (and the unaligned

-malign-double

2009-11-15 Thread Barry Smith
require 16 byte alignment everywhere? But is that a desirable? Barry On Nov 14, 2009, at 12:43 PM, Jed Brown wrote: Barry Smith wrote: On Nov 14, 2009, at 11:28 AM, Jed Brown wrote: Barry Smith wrote: Good point, I have removed it. I put it in because I wanted an easy way to test

Should PetscObjectName be collective?

2009-11-16 Thread Barry Smith
, Jed Brown wrote: Barry Smith wrote: I do not know a way to generate unique MPI-comm-id's. Any thoughts? Some feature of MPI I don't know? This seems very hard. One could (the first time PETSc sees a communicator) hash the hostname+pid of every process on the communicator, start a counter

-malign-double

2009-11-16 Thread Barry Smith
would argue yes. Not only is there the issue of improved performance of the malloc but it also is a nice way to have clarity in the code as to what allocated arrays are associated together. Barry I'm not sure.. Satish On Mon, 16 Nov 2009, Jed Brown wrote: Barry Smith wrote

-malign-double

2009-11-16 Thread Barry Smith
What about have configure look for uintptr_t if it does not exist then have configure check if unsigned long long is large enough, if not try size_t otherwise barf? Barry On Nov 16, 2009, at 1:55 PM, Jed Brown wrote: Barry Smith wrote: Jed, Seems ok to me. Feel free

-malign-double

2009-11-17 Thread Barry Smith
On Nov 16, 2009, at 2:50 PM, Jed Brown wrote: so. BTW, should we put PAPI support into PETSc, it no longer needs kernel patches with 2.6.31. The basics are there in config/PETSc/packages/PAPI.py and initialization in plog.c and eventLog.c It would be good to add counts for cache

-malign-double

2009-11-17 Thread Barry Smith
Thanks On Nov 17, 2009, at 1:08 PM, Jed Brown wrote: I think this is complete. http://petsc.cs.iit.edu/petsc/petsc-dev/rev/a36906938641 This was my first time messing with configure. It works in all cases I have tested, let me know if I screwed up. The default alignment is now

-malign-double

2009-11-17 Thread Barry Smith
On Nov 17, 2009, at 3:13 PM, Jed Brown wrote: Barry Smith wrote: On Nov 16, 2009, at 2:50 PM, Jed Brown wrote: so. BTW, should we put PAPI support into PETSc, it no longer needs kernel patches with 2.6.31. The basics are there in config/PETSc/packages/PAPI.py and This file does

Should PetscObjectName be collective?

2009-11-17 Thread Barry Smith
On Nov 17, 2009, at 5:08 PM, Jed Brown wrote: Lisandro Dalcin wrote: On Mon, Nov 16, 2009 at 4:04 PM, Barry Smith bsmith at mcs.anl.gov wrote: Ok, we could just put the counter into the MPI attribute and then just have uniqueness of the names within each communicator. This would

cleaning up two very nasty coding habits

2009-11-17 Thread Barry Smith
When starting to code PETSc 2.0 I introduced two nasty habits 1) since we called malloc() directly and some mallocs don't like allocating zero length I would often allocate 1 additional space to make sure I did not request a zero size. Giving things like

Should PetscObjectName be collective?

2009-11-18 Thread Barry Smith
On Nov 18, 2009, at 8:52 AM, Jed Brown wrote: http://petsc.cs.iit.edu/petsc/petsc-dev/rev/ecbd2dcad71a Note that there are a couple other places where keyvals are created (with no way to free them). Does it make sense to put those fields into this one? Is there a reason that

Why did you removed PETSC_ARCH_NAME variable in makefiles?

2009-11-25 Thread Barry Smith
Lisandro, That change will certainly NOT be reverted. PETSC_ARCH_NAME! what the heck kind of variable name is that? I need to understand the reason for PETSC_ARCH_NAME, then we can come up with some solution. What is the difference between PETSC_ARCH_NAME and PETSC_ARCH? Is

Why did you removed PETSC_ARCH_NAME variable in makefiles?

2009-11-25 Thread Barry Smith
way of supporting that case. Jose On 25/11/2009, Barry Smith wrote: Lisandro, That change will certainly NOT be reverted. PETSC_ARCH_NAME! what the heck kind of variable name is that? I need to understand the reason for PETSC_ARCH_NAME, then we can come up with some

Why did you removed PETSC_ARCH_NAME variable in makefiles?

2009-11-25 Thread Barry Smith
On Nov 25, 2009, at 1:03 PM, Lisandro Dalcin wrote: On Wed, Nov 25, 2009 at 3:19 PM, Barry Smith bsmith at mcs.anl.gov wrote: Lisandro, That change will certainly NOT be reverted. PETSC_ARCH_NAME! what the heck kind of variable name is that? I agree the name could be messy

Why did you removed PETSC_ARCH_NAME variable in makefiles?

2009-11-27 Thread Barry Smith
On Nov 27, 2009, at 6:04 PM, Lisandro Dalcin wrote: On Fri, Nov 27, 2009 at 8:52 PM, Satish Balay balay at mcs.anl.gov wrote: On Fri, 27 Nov 2009, Satish Balay wrote: This tread got long enough. Let's stop here, please. All us have more important matters to spend our time. I think I'll

Why did you removed PETSC_ARCH_NAME variable in makefiles?

2009-11-29 Thread Barry Smith
I have made some changes so that when using the --prefix option there is no need to set PETSC_DIR or PETSC_ARCH. ./configure --prefix=... other options make make install Barry On Nov 27, 2009, at 5:47 PM, Satish Balay wrote: On Fri, 27 Nov 2009, Barry Smith wrote: How does

PETSC_ARCH variable -- PETSC_CONF

2009-11-30 Thread Barry Smith
Lisandro has pointed out to me several times that the variable name PETSC_ARCH can be confusing; some people may think it is related to the architecture of the machine and don't understand that it is an arbitrary name that the user can make up. He suggested changing it to PETSC_CONF

PETSC_ARCH variable -- PETSC_CONF

2009-11-30 Thread Barry Smith
PM, Matthew Knepley wrote: I see the point, but this is one of the oldest parts of PETSc, and I am hesitant to change one arbitrary name to another without a more convincing reason. Matt On Mon, Nov 30, 2009 at 2:17 PM, Barry Smith bsmith at mcs.anl.gov wrote: Lisandro has

PETSC_ARCH variable -- PETSC_CONF

2009-11-30 Thread Barry Smith
/ On Nov 30, 2009, at 3:43 PM, Matthew Knepley wrote: On Mon, Nov 30, 2009 at 3:38 PM, Barry Smith bsmith at mcs.anl.gov wrote: I guess the argument is that on occasion in the future a certain number of people will misinterpret the meaning of PETSC_ARCH frustrating them and us; the number

PETSC_ARCH variable -- PETSC_CONF

2009-11-30 Thread Barry Smith
Boyana, We are going to stop using make before we ever start using GNU make features :-) Barry On Nov 30, 2009, at 4:23 PM, Boyana Norris wrote: On Nov 30, 2009, at 3:59 PM, Barry Smith wrote: On Nov 30, 2009, at 3:51 PM, Boyana Norris wrote: Why not recognize both? It's

PETSC_ARCH variable -- PETSC_CONF

2009-11-30 Thread Barry Smith
PM, Barry Smith wrote: Boyana, We are going to stop using make before we ever start using GNU make features :-) Barry On Nov 30, 2009, at 4:23 PM, Boyana Norris wrote: On Nov 30, 2009, at 3:59 PM, Barry Smith wrote: On Nov 30, 2009, at 3:51 PM, Boyana Norris wrote: Why

PETSc in double-double and quad-double...

2009-11-04 Thread Barry Smith
This is tricky because some C/C++ compilers long double uses 128 bits of space but actually (on Intel) only uses 80 of the bits (those are the bits that floating point unit handles). So you do not really get 128 bits. Also MPI may not properly handle the 128 bit doubles. I am

C/F blas/lapack (tying to build in cygwin)

2009-03-21 Thread Barry Smith
The cblaslapack binding does not, in general, match any particular Fortran compiler, thus calling cblaslapack from some Fortran compiler might not work. To prevent this situation we have the check that you hit below. It would be good to figure out why gfortran could not handle the

MatMult_Scatter woes

2009-03-30 Thread Barry Smith
I don't think square has anything to do with it. It depends on whether all the entries in y[i] are hit or if some are skipped, this depends exactly on the scatter. The first time the mult is called, duplicate x and y temporarility, fill a xdup with all 1s. Do the scatter, locate

MatMult_Scatter woes

2009-03-30 Thread Barry Smith
On Mar 30, 2009, at 7:48 PM, Matthew Knepley wrote: On Mon, Mar 30, 2009 at 6:13 PM, Barry Smith bsmith at mcs.anl.gov wrote: I don't think square has anything to do with it. It depends on whether all the entries in y[i] are hit or if some are skipped, this depends exactly

PC_FieldSplitLink

2009-07-10 Thread Barry Smith
I just used a link list to support flexibly adding more fields without needing to allocate a new array and copying over the old values. If array storage makes the implementation easier that is fine with me. Since there are not many blocks why bother with CSR to store the (say 5 by 5 = 25

please take care to fix all examples that us an API you changed

2009-07-16 Thread Barry Smith
Recently people have been changing calling sequences of some PETSc routines (which is fine) but NOT changing all the examples that use the API (which is not fine). Thus breaking the tests. Whenever you change an API please check all the examples (with etags this is trivial) and update

please take care to fix all examples that us an API you changed

2009-07-17 Thread Barry Smith
On Jul 17, 2009, at 1:59 PM, Jed Brown wrote: I was responsible for some of these failures, they are working now. Thanks I see differences in the last digit for a lot of tests which contaminates the output. The use of -xxx_monitor_short should take care of most architecture

PETSc Tutorial during ACTS

2009-07-17 Thread Barry Smith
Tony, I will not be able to make it this year and I believe Matt is also previously booked. I'm forwarding this to the wider development team to see if we have any volunteers. If a non-ANL person presents can you pay for travel and expenses? Barry On Jul 17, 2009, at 12:36

Chat for coding collaboration

2009-07-20 Thread Barry Smith
I want to use may mail reader as my front end Barry It happens to be Mail.app but that is not important On Jul 20, 2009, at 2:41 PM, Andy Ray Terrel wrote: This is what irc is for and why lots of open source codes are on freenode servers. http://freenode.net/ Then you can pick

release-3.0.0 broken for C++ builds

2009-07-20 Thread Barry Smith
Sorry, fixed. Say, isn't it about time we abolish PetscTruth? Are the C and C++ bool compatible with each other and compatible with Fortran 90's logical? Barry On Jul 20, 2009, at 12:51 PM, Lisandro Dalcin wrote: Barry, this time you are the guy to blame ;-) (at least for the

release-3.0.0 broken for C++ builds

2009-07-20 Thread Barry Smith
On Jul 20, 2009, at 3:35 PM, Lisandro Dalcin wrote: On Mon, Jul 20, 2009 at 5:01 PM, Barry Smithbsmith at mcs.anl.gov wrote: Sorry, fixed. Say, isn't it about time we abolish PetscTruth? Are the C and C++ bool compatible with each other and compatible with Fortran 90's logical?

Fwd: SNESSetUp() and matrix-free options

2009-07-21 Thread Barry Smith
is to save the mf flags in the SNES data structure and call SNESSetUpMatrixFree_Private() as it use to be called in SNESSetUp(). Perhaps there is a problem with that fix I do not know about. Barry Begin forwarded message: From: Barry Smith bsmith at mcs.anl.gov Date: May 6, 2009 3:25:43

SNESSetUp() and matrix-free options

2009-07-21 Thread Barry Smith
that does not follow the rules. Begin forwarded message: From: Barry Smith bsmith at mcs.anl.gov Date: May 6, 2009 3:25:43 PM CDT To: For users of the development version of PETSc petsc-dev at mcs.anl.gov Subject: Re: SNESSetUp() and matrix-free options Lisandro, The checking

Setting options on matrices obtained from a DM

2009-07-21 Thread Barry Smith
My eventual goal is to remove all hidden MatCreate()'s and instead have Mat's passed in as arguments. So MatLoad() would take a Mat as an argument, as would DAGetMatrix() One could then set as much or a as little as a Mat as they like before passing it in. They could set the type, they

Setting options on matrices obtained from a DM

2009-07-21 Thread Barry Smith
On Jul 21, 2009, at 7:00 PM, Jed Brown wrote: Barry Smith wrote: My eventual goal is to remove all hidden MatCreate()'s and instead have Mat's passed in as arguments. So MatLoad() would take a Mat as an argument, as would DAGetMatrix() One could then set as much or a as little as a Mat

Setting options on matrices obtained from a DM

2009-07-21 Thread Barry Smith
On Jul 21, 2009, at 7:47 PM, Jed Brown wrote: Barry Smith wrote: Could you call MatSetFromOptions() twice, once before the DAGetMatrix() call to set the type and then after the DAGetMatrix() to set particular options for what you set? This is okay as long as we don't get more global

  1   2   3   4   5   6   7   8   9   10   >