#include "petscmat.h" PetscErrorCode MatCreateSeqSBAIJ(MPI_Comm comm,PetscInt bs,PetscInt m,PetscInt n,PetscInt nz,const PetscInt nnz[],Mat *A)Collective on MPI_Comm
| comm | - MPI communicator, set to PETSC_COMM_SELF | |
| bs | - size of block | |
| m | - number of rows, or number of columns | |
| nz | - number of block nonzeros per block row (same for all rows) | |
| nnz | - array containing the number of block nonzeros in the upper triangular plus diagonal portion of each block (possibly different for each block row) or PETSC_NULL | 
It is recommended that one use the MatCreate(), MatSetType() and/or MatSetFromOptions(), MatXXXXSetPreallocation() paradgm instead of this routine directly. [MatXXXXSetPreallocation() is, for example, MatSeqAIJSetPreallocation]
|   MatCreateSeqSBAIJ(PetscInt bs,PetscInt m,PetscInt n,Mat *A) | -> | MatCreateSeqSBAIJ(PETSC_COMM_SELF,bs,m,n,0,PETSC_NULL,A) | |||
|   MatCreateSeqSBAIJ(PetscInt bs,PetscInt m,PetscInt n,const PetscInt nnz[],Mat *A) | -> | MatCreateSeqSBAIJ(PETSC_COMM_SELF,bs,m,n,0,nnz,A) | |||
|   MatCreateSeqSBAIJ(PetscInt bs,PetscInt m,PetscInt n,PetscInt nz,Mat *A) | -> | MatCreateSeqSBAIJ(PETSC_COMM_SELF,bs,m,n,nz,PETSC_NULL,A) | |||
| Mat MatCreateSeqSBAIJ(PetscInt bs,PetscInt m,PetscInt n) | -> | MatCreateSeqSBAIJ(PETSC_COMM_SELF,bs,m,n,0,PETSC_NULL,&A); return A; | |||
| Mat MatCreateSeqSBAIJ(PetscInt bs,PetscInt m,PetscInt n,const PetscInt nnz[]) | -> | MatCreateSeqSBAIJ(PETSC_COMM_SELF,bs,m,n,0,nnz,&A); return A; | |||
| Mat MatCreateSeqSBAIJ(PetscInt bs,PetscInt m,PetscInt n,PetscInt nz) | -> | MatCreateSeqSBAIJ(PETSC_COMM_SELF,bs,m,n,nz,PETSC_NULL,&A); return A; | |||
| Mat MatCreateSeqSBAIJ(PetscInt bs,PetscInt m,PetscInt n,PetscInt nz,const PetscInt nnz[]) | -> | MatCreateSeqSBAIJ(PETSC_COMM_SELF,bs,m,n,nz,nnz,&A); return A; | 
Specify the preallocated storage with either nz or nnz (not both). Set nz=PETSC_DEFAULT and nnz=PETSC_NULL for PETSc to control dynamic memory allocation. See the <a href="../../docs/manual.pdf#nameddest=ch_mat">Mat chapter of the users manual</a> for details.
If the nnz parameter is given then the nz parameter is ignored
Level:intermediate
Location:src/mat/impls/sbaij/seq/sbaij.c
Index of all Mat routines
Table of Contents for all manual pages
Index of all manual pages