<html>
<head>
<style><!--
.hmmessage P
{
margin:0px;
padding:0px
}
body.hmmessage
{
font-size: 10pt;
font-family:Tahoma
}
--></style>
</head>
<body class='hmmessage'>
I am trying to create a matrix and insert values to it. The martix is supposed to be as following:<BR>
&nbsp;<BR>
1&nbsp; &nbsp;0&nbsp;&nbsp;&nbsp; 0&nbsp; &nbsp;0<BR>
0&nbsp;&nbsp; 2&nbsp;&nbsp;&nbsp; 0&nbsp;&nbsp; 0<BR>
0&nbsp;&nbsp; 0&nbsp;&nbsp;&nbsp; 3&nbsp;&nbsp; 0<BR>
0&nbsp;&nbsp; 0&nbsp;&nbsp;&nbsp; 0&nbsp;&nbsp; 4<BR>
&nbsp;<BR>
array&nbsp; coef[] is the diagonal&nbsp;value of the matrix, <BR>
&nbsp;&nbsp;&nbsp;&nbsp;&nbsp;&nbsp;&nbsp;&nbsp; snr[] is the index of the row, rnr[] is the index of column.<BR>
&nbsp;<BR>
However, I always get the wrong results. It shows the Column too large: col 4607182418800017408 max 3!&nbsp;&nbsp;&nbsp; &nbsp;I cheked the value of rnr[].&nbsp; The output snr and rnr is correct:<BR>
snr=&nbsp;&nbsp; 0&nbsp;&nbsp; 1&nbsp;&nbsp; 2&nbsp;&nbsp; 3<BR>rnr=&nbsp;&nbsp; 0&nbsp;&nbsp; 1&nbsp;&nbsp; 2&nbsp;&nbsp; 3<BR>
&nbsp;<BR>
It seems there is something wrong when MatSetValues() is called. Following is a part of the error information. The information is shown at each loop of&nbsp; do II=Istart,Iend-1<BR>
&nbsp;<BR>
The output (if any) follows:<BR>
snr=&nbsp;&nbsp; 0&nbsp;&nbsp; 1&nbsp;&nbsp; 2&nbsp;&nbsp; 3<BR>rnr=&nbsp;&nbsp; 0&nbsp;&nbsp; 1&nbsp;&nbsp; 2&nbsp;&nbsp; 3<BR>8.....Check after MatGetOwnershipRange() Istart=&nbsp;&nbsp;&nbsp;&nbsp;&nbsp; 0&nbsp; Iend=&nbsp;&nbsp;&nbsp;&nbsp;&nbsp; 4<BR>II=&nbsp;&nbsp;&nbsp;&nbsp;&nbsp; 0&nbsp;&nbsp;&nbsp;&nbsp;&nbsp; 1&nbsp;&nbsp;&nbsp;&nbsp;&nbsp; 0&nbsp;&nbsp;&nbsp;&nbsp;&nbsp; 0<BR>[0]PETSC ERROR: --------------------- Error Message ------------------------------------<BR>[0]PETSC ERROR: Argument out of range!<BR>[0]PETSC ERROR: Column too large: col 4607182418800017408 max 3!<BR>[0]PETSC ERROR: ------------------------------------------------------------------------<BR>[0]PETSC ERROR: Petsc Release Version 3.1.0, Patch 5, Mon Sep 27 11:51:54 CDT 2010<BR>[0]PETSC ERROR: See docs/changes/index.html for recent updates.<BR>[0]PETSC ERROR: See docs/faq.html for hints about trouble shooting.<BR>[0]PETSC ERROR: See docs/index.html for manual pages.<BR>[0]PETSC ERROR: ------------------------------------------------------------------------<BR>[0]PETSC ERROR: Debug_PETSc_MatCreate_20101130 on a linux-gnu named compute-1-35.hpc.local.uwm by pwang_a Tue Nov 30 22:27:03 2010<BR>[0]PETSC ERROR: Libraries linked from /sharedapps/uwm/ceas/gcc-4.4.3/petsc/3.1-p5-v1/lib<BR>[0]PETSC ERROR: Configure run at Fri Oct&nbsp; 8 12:59:16 2010<BR>[0]PETSC ERROR: Configure options --prefix=/sharedapps/uwm/ceas/gcc-4.4.3/petsc/3.1-p5-v1 --with-mpi-dir=/sharedapps/uwm/common/gcc-4.4.3/openmpi/1.3.2-v1 --with-blas-lapack-dir=/sharedapps/uwm/ceas/gcc-4.4.3/lapack/3.2.2-v1/lib --with-64-bit-indices=1 --with-64-bit-pointers=1 --with-large-file-io=1 --with-x=0<BR>[0]PETSC ERROR: ------------------------------------------------------------------------<BR>[0]PETSC ERROR: MatSetValues_SeqAIJ() line 193 in src/mat/impls/aij/seq/aij.c<BR>[0]PETSC ERROR: MatSetValues() line 992 in src/mat/interface/matrix.c<BR><BR><BR>
&nbsp;<BR>
!The code is as following:<BR>
!=============================<BR>
program Debug_PETSc_MatCreate_20101130<BR>
implicit none<BR>!<BR>#include "finclude/petscsys.h"<BR>#include "finclude/petscvec.h"<BR>#include "finclude/petscmat.h"<BR>#include "finclude/petscpc.h"<BR>#include "finclude/petscksp.h"<BR>! Variables<BR>!- - - - - - - - - - - - - - - - - - - - - - - - - - - - - <BR>!&nbsp; PETSc Variables<BR>!- - - - - - - - - - - - - - - - - - - - - - - - - - - - - <BR>&nbsp;&nbsp;&nbsp;&nbsp;&nbsp; real*8&nbsp; norm<BR>&nbsp;&nbsp;&nbsp;&nbsp;&nbsp; PetscInt&nbsp; i,j,II,JJ,its&nbsp;&nbsp; !,m,n<BR>&nbsp;&nbsp;&nbsp;&nbsp;&nbsp; PetscInt&nbsp; Istart,Iend,ione<BR>&nbsp;&nbsp;&nbsp;&nbsp;&nbsp; PetscErrorCode ierr<BR>&nbsp;&nbsp;&nbsp;&nbsp;&nbsp; PetscMPIInt&nbsp;&nbsp;&nbsp;&nbsp; myid,numprocs<BR>&nbsp;&nbsp;&nbsp;&nbsp;&nbsp; PetscTruth&nbsp; flg<BR>&nbsp;&nbsp;&nbsp;&nbsp;&nbsp; PetscScalar v,one,neg_one<BR>&nbsp;&nbsp;&nbsp;&nbsp;&nbsp; Vec&nbsp;&nbsp;&nbsp;&nbsp;&nbsp;&nbsp;&nbsp;&nbsp; x,b,u<BR>&nbsp;&nbsp;&nbsp;&nbsp;&nbsp; Mat&nbsp;&nbsp;&nbsp;&nbsp;&nbsp;&nbsp;&nbsp;&nbsp; A_petsc <BR>&nbsp;&nbsp;&nbsp;&nbsp;&nbsp; KSP&nbsp;&nbsp;&nbsp;&nbsp;&nbsp;&nbsp;&nbsp;&nbsp; ksp<BR>&nbsp;&nbsp;&nbsp;&nbsp;&nbsp; PetscInt,parameter::&nbsp;&nbsp;&nbsp; n_nz=4<BR>!- - - - - - - - - - - - - - - - - - - - - - - - - - - - - <BR>!&nbsp; Other Variables<BR>!- - - - - - - - - - - - - - - - - - - - - - - - - - - - - <BR>!parameter::n_nz=4<BR>Real*8::Coef(n_nz)<BR>PetscInt::snr(n_nz),rnr(n_nz)<BR>data Coef /1.,&nbsp;&nbsp; 2.,&nbsp;&nbsp;&nbsp; 3. ,&nbsp; 4./<BR>data snr&nbsp; /0,&nbsp;&nbsp;&nbsp; 1,&nbsp;&nbsp;&nbsp;&nbsp; 2,&nbsp;&nbsp;&nbsp; 3/<BR>data rnr&nbsp; /0,&nbsp;&nbsp;&nbsp; 1 ,&nbsp;&nbsp;&nbsp; 2,&nbsp;&nbsp;&nbsp; 3/<BR>
! Body of Debug_PETSc_MatCreate_20101130<BR>
! - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - -<BR>!&nbsp;&nbsp;&nbsp;&nbsp;&nbsp;&nbsp;&nbsp;&nbsp;&nbsp;&nbsp;&nbsp;&nbsp;&nbsp;&nbsp;&nbsp;&nbsp; Beginning of program<BR>! - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - <BR>&nbsp;&nbsp;&nbsp; call PetscInitialize(PETSC_NULL_CHARACTER,ierr)<BR>&nbsp;&nbsp;&nbsp; call MPI_Comm_rank(PETSC_COMM_WORLD,myid,ierr)<BR>&nbsp;&nbsp;&nbsp; call MPI_Comm_size(PETSC_COMM_WORLD,numprocs,ierr)<BR>
&nbsp;&nbsp;&nbsp;&nbsp;&nbsp;&nbsp;&nbsp; write(*,"('snr=',4i4)")snr&nbsp;&nbsp;&nbsp;&nbsp; <BR>&nbsp;&nbsp;&nbsp;&nbsp;&nbsp;&nbsp;&nbsp; write(*,"('rnr=',4i4)")rnr&nbsp;&nbsp;&nbsp;&nbsp; <BR>&nbsp;&nbsp;&nbsp; call MatCreate(PETSC_COMM_WORLD,A_Petsc,ierr)<BR>&nbsp;&nbsp;&nbsp; call MatSetSizes(A_Petsc,PETSC_DECIDE,PETSC_DECIDE,n_nz,n_nz,ierr)&nbsp;&nbsp;&nbsp; !n_nz-1???<BR>&nbsp;&nbsp;&nbsp; call MatSetFromOptions(A_Petsc,ierr)<BR>
&nbsp;&nbsp;&nbsp; !&nbsp;&nbsp;&nbsp; write(*,*)A_petsc<BR>&nbsp;&nbsp;&nbsp; call MatGetOwnershipRange(A_Petsc,Istart,Iend,ierr)<BR>&nbsp;&nbsp;&nbsp; <BR>&nbsp;&nbsp;&nbsp; write(*,'(1a,1i7,1a,1i7)')&nbsp; &amp;<BR>&nbsp;&nbsp;&nbsp;&nbsp;&nbsp;&nbsp;&nbsp;&nbsp;&nbsp;&nbsp;&nbsp; '8.....Check after MatGetOwnershipRange() Istart=',Istart,'&nbsp; Iend=',Iend<BR>
&nbsp;&nbsp;&nbsp; do II=Istart,Iend-1<BR>&nbsp;&nbsp;&nbsp;&nbsp;&nbsp;&nbsp;&nbsp; ione=II+1 !(Coef,snr,rnr are 1-based row and column numbers, shifting them to 0-based)<BR>&nbsp;&nbsp;&nbsp;&nbsp;&nbsp;&nbsp;&nbsp;&nbsp;&nbsp;&nbsp;&nbsp; write(*,'(1a,4i7)')'II=',II,ione,snr(ione),rnr(ione)&nbsp; !output snr and rnr for&nbsp;error check<BR>&nbsp;&nbsp;&nbsp;&nbsp;&nbsp;&nbsp;&nbsp; call MatSetValues(A_Petsc,1,snr(Ione),1,rnr(Ione),Coef(Ione),INSERT_VALUES,ierr)<BR>&nbsp;&nbsp;&nbsp; enddo <BR>&nbsp;&nbsp;&nbsp; <BR>&nbsp;&nbsp;&nbsp;&nbsp;&nbsp;&nbsp;&nbsp; write(*,'(1a)')'9.....Check after MatSetValues()'<BR>&nbsp;&nbsp;&nbsp; call MatAssemblyBegin(A_petsc,MAT_FINAL_ASSEMBLY,ierr)<BR>&nbsp;&nbsp;&nbsp; call MatAssemblyEnd(A_Petsc,MAT_FINAL_ASSEMBLY,ierr)<BR>&nbsp;&nbsp;&nbsp;&nbsp;&nbsp;&nbsp;&nbsp; write(*,'(1a)')'10.....Check after MatCreate()'<BR>&nbsp;&nbsp;&nbsp; call MatView(A_Petsc,PETSC_VIEWER_STDOUT_WORLD,ierr)<BR>
!&nbsp;&nbsp;&nbsp;&nbsp;&nbsp; call KSPDestroy(ksp,ierr)<BR>!&nbsp;&nbsp;&nbsp;&nbsp;&nbsp; call VecDestroy(u,ierr)<BR>!&nbsp;&nbsp;&nbsp;&nbsp;&nbsp; call VecDestroy(x,ierr)<BR>!&nbsp;&nbsp;&nbsp;&nbsp;&nbsp; call VecDestroy(b,ierr)<BR>&nbsp;&nbsp;&nbsp; call MatDestroy(A_petsc,ierr)<BR>
&nbsp;&nbsp;&nbsp; call PetscFinalize(ierr)<BR>end program Debug_PETSc_MatCreate_20101130<BR>
!=====================================<BR>                                               </body>
</html>