# This is a BitKeeper generated diff -Nru style patch. # # ChangeSet # 2004/05/08 12:24:15-05:00 balay@asterix.mcs.anl.gov # Fix Spooles & MUMPS interface bug (backport from petsc-dev) # # src/mat/impls/sbaij/seq/spooles/sbaijspooles.c # 2004/05/08 12:23:56-05:00 balay@asterix.mcs.anl.gov +1 -1 # Fix Spooles & MUMPS interface bug # # src/mat/impls/aij/mpi/mumps/mumps.c # 2004/05/08 12:23:56-05:00 balay@asterix.mcs.anl.gov +2 -2 # Fix Spooles & MUMPS interface bug # # include/petscversion.h # 2004/05/08 12:23:56-05:00 balay@asterix.mcs.anl.gov +2 -2 # Fix Spooles & MUMPS interface bug # diff -Nru a/include/petscversion.h b/include/petscversion.h --- a/include/petscversion.h Sat May 8 12:24:52 2004 +++ b/include/petscversion.h Sat May 8 12:24:52 2004 @@ -15,8 +15,8 @@ #define PETSC_VERSION_MAJOR 2 #define PETSC_VERSION_MINOR 2 #define PETSC_VERSION_SUBMINOR 0 -#define PETSC_VERSION_PATCH 0 -#define PETSC_VERSION_DATE "Feb 27, 2004" +#define PETSC_VERSION_PATCH 1 +#define PETSC_VERSION_DATE "May 8, 2004" #define PETSC_AUTHOR_INFO "\ The PETSc Team\n\ petsc-maint@mcs.anl.gov\n\ diff -Nru a/src/mat/impls/aij/mpi/mumps/mumps.c b/src/mat/impls/aij/mpi/mumps/mumps.c --- a/src/mat/impls/aij/mpi/mumps/mumps.c Sat May 8 12:24:52 2004 +++ b/src/mat/impls/aij/mpi/mumps/mumps.c Sat May 8 12:24:52 2004 @@ -663,8 +663,8 @@ /* Create the factorization matrix */ ierr = MatCreate(A->comm,A->m,A->n,A->M,A->N,&B);CHKERRQ(ierr); ierr = MatSetType(B,A->type_name);CHKERRQ(ierr); - ierr = MatSeqAIJSetPreallocation(B,0,PETSC_NULL);CHKERRQ(ierr); - ierr = MatMPIAIJSetPreallocation(B,0,PETSC_NULL,0,PETSC_NULL);CHKERRQ(ierr); + ierr = MatSeqSBAIJSetPreallocation(B,1,0,PETSC_NULL);CHKERRQ(ierr); + ierr = MatMPISBAIJSetPreallocation(B,1,0,PETSC_NULL,0,PETSC_NULL);CHKERRQ(ierr); B->ops->choleskyfactornumeric = MatFactorNumeric_AIJMUMPS; B->ops->getinertia = MatGetInertia_SBAIJMUMPS; diff -Nru a/src/mat/impls/sbaij/seq/spooles/sbaijspooles.c b/src/mat/impls/sbaij/seq/spooles/sbaijspooles.c --- a/src/mat/impls/sbaij/seq/spooles/sbaijspooles.c Sat May 8 12:24:52 2004 +++ b/src/mat/impls/sbaij/seq/spooles/sbaijspooles.c Sat May 8 12:24:52 2004 @@ -71,7 +71,7 @@ /* Create the factorization matrix */ ierr = MatCreate(A->comm,m,n,m,n,&B); ierr = MatSetType(B,A->type_name);CHKERRQ(ierr); - ierr = MatSeqAIJSetPreallocation(B,PETSC_NULL,PETSC_NULL);CHKERRQ(ierr); + ierr = MatSeqSBAIJSetPreallocation(B,1,PETSC_NULL,PETSC_NULL);CHKERRQ(ierr); B->ops->choleskyfactornumeric = MatFactorNumeric_SeqAIJSpooles; B->ops->getinertia = MatGetInertia_SeqSBAIJSpooles; # This is a BitKeeper generated diff -Nru style patch. # # ChangeSet # 2004/05/10 16:16:23-05:00 balay@asterix.mcs.anl.gov # Fix MatDuplicate issues with external packages # # src/mat/impls/sbaij/seq/sbaij.c # 2004/05/10 16:16:22-05:00 balay@asterix.mcs.anl.gov +1 -1 # Fix MatDuplicate issues with external packages # # src/mat/impls/aij/seq/aij.c # 2004/05/10 16:16:22-05:00 balay@asterix.mcs.anl.gov +1 -1 # Fix MatDuplicate issues with external packages # # src/mat/impls/aij/mpi/mpiaij.c # 2004/05/10 16:16:22-05:00 balay@asterix.mcs.anl.gov +1 -1 # Fix MatDuplicate issues with external packages # # include/petscversion.h # 2004/05/10 16:16:22-05:00 balay@asterix.mcs.anl.gov +2 -2 # another patch # diff -Nru a/include/petscversion.h b/include/petscversion.h --- a/include/petscversion.h Mon May 10 16:17:06 2004 +++ b/include/petscversion.h Mon May 10 16:17:06 2004 @@ -15,8 +15,8 @@ #define PETSC_VERSION_MAJOR 2 #define PETSC_VERSION_MINOR 2 #define PETSC_VERSION_SUBMINOR 0 -#define PETSC_VERSION_PATCH 1 -#define PETSC_VERSION_DATE "May 8, 2004" +#define PETSC_VERSION_PATCH 2 +#define PETSC_VERSION_DATE "May 10, 2004" #define PETSC_AUTHOR_INFO "\ The PETSc Team\n\ petsc-maint@mcs.anl.gov\n\ diff -Nru a/src/mat/impls/aij/mpi/mpiaij.c b/src/mat/impls/aij/mpi/mpiaij.c --- a/src/mat/impls/aij/mpi/mpiaij.c Mon May 10 16:17:05 2004 +++ b/src/mat/impls/aij/mpi/mpiaij.c Mon May 10 16:17:05 2004 @@ -1875,7 +1875,7 @@ ierr = MatCreate(matin->comm,matin->m,matin->n,matin->M,matin->N,&mat);CHKERRQ(ierr); ierr = MatSetType(mat,matin->type_name);CHKERRQ(ierr); a = (Mat_MPIAIJ*)mat->data; - ierr = PetscMemcpy(mat->ops,&MatOps_Values,sizeof(struct _MatOps));CHKERRQ(ierr); + /* ierr = PetscMemcpy(mat->ops,&MatOps_Values,sizeof(struct _MatOps));CHKERRQ(ierr); */ mat->factor = matin->factor; mat->assembled = PETSC_TRUE; mat->insertmode = NOT_SET_VALUES; diff -Nru a/src/mat/impls/aij/seq/aij.c b/src/mat/impls/aij/seq/aij.c --- a/src/mat/impls/aij/seq/aij.c Mon May 10 16:17:05 2004 +++ b/src/mat/impls/aij/seq/aij.c Mon May 10 16:17:05 2004 @@ -2739,7 +2739,7 @@ c->nz = a->nz; c->maxnz = a->maxnz; c->solve_work = 0; - C->spptr = 0; /* Dangerous -I'm throwing away a->spptr */ + /* C->spptr = 0; */ /* Dangerous -I'm throwing away a->spptr */ C->preallocated = PETSC_TRUE; *B = C; diff -Nru a/src/mat/impls/sbaij/seq/sbaij.c b/src/mat/impls/sbaij/seq/sbaij.c --- a/src/mat/impls/sbaij/seq/sbaij.c Mon May 10 16:17:05 2004 +++ b/src/mat/impls/sbaij/seq/sbaij.c Mon May 10 16:17:06 2004 @@ -1786,7 +1786,7 @@ c->nz = a->nz; c->maxnz = a->maxnz; c->solve_work = 0; - C->spptr = 0; /* Dangerous -I'm throwing away a->spptr */ + /* C->spptr = 0; */ /* Dangerous -I'm throwing away a->spptr */ c->mult_work = 0; *B = C; ierr = PetscFListDuplicate(A->qlist,&C->qlist);CHKERRQ(ierr);