//Variables
PetscScalar gamma, alpha, oldgamma, beta;
- PetscReal norm=20, Eprecision=1e-8, cgprec=1e-40;
+ PetscReal norm=20, Eprecision=1e-6, cgprec=1e-40;
PetscInt giter=0, ColS=12, col=0, Emaxiter=50000000, iter=0, iterations=15, Iiter=0;
PetscErrorCode ierr;
PetscScalar T1, T2;
//Initializations
// ierr = KSPGMRESSetRestart(ksp, 16); CHKERRQ(ierr);
- ierr = KSPSetTolerances(ksp, 1e-13, 1e-13, PETSC_DEFAULT, 16); CHKERRQ(ierr);
+ ierr = KSPSetTolerances(ksp, 1e-13, 1e-13, PETSC_DEFAULT, 30); CHKERRQ(ierr);
ierr = KSPSetInitialGuessNonzero(ksp, PETSC_TRUE); CHKERRQ(ierr);
//GMRES WITH MINIMIZATION
T1 = MPI_Wtime();
+ ierr = KSPSetUp(ksp); CHKERRQ(ierr);
while(giter<Emaxiter && norm>Eprecision ){
for(col=0; col<ColS && norm>Eprecision; col++){
//Variables
PetscScalar alpha, beta;
- PetscReal norm=20, Eprecision=1e-8, tol=1e-40;
+ PetscReal norm=20, Eprecision=1e-6, tol=1e-40;
PetscInt giter=0, ColS=12, col=0, Emaxiter=50000000, iter=0, iterations=20, Iiter=0;
PetscErrorCode ierr;
PetscScalar T1, T2;
//Initializations
// ierr = KSPGMRESSetRestart(ksp, 16); CHKERRQ(ierr);
- ierr = KSPSetTolerances(ksp, 1e-10, 1e-10, PETSC_DEFAULT, 16); CHKERRQ(ierr);
+ ierr = KSPSetTolerances(ksp, 1e-13, 1e-13, PETSC_DEFAULT, 30); CHKERRQ(ierr);
ierr = KSPSetInitialGuessNonzero(ksp, PETSC_TRUE); CHKERRQ(ierr);
//GMRES WITH MINIMIZATION
T1 = MPI_Wtime();
+ ierr = KSPSetUp(ksp); CHKERRQ(ierr);
while(giter<Emaxiter && norm>Eprecision ){
for(col=0; col<ColS && norm>Eprecision; col++){
ierr = PetscOptionsGetInt(NULL,"-m",&m,NULL);CHKERRQ(ierr);
ierr = PetscOptionsGetInt(NULL,"-n",&n,NULL);CHKERRQ(ierr);
+ PetscMPIInt size;
+ MPI_Comm_size(PETSC_COMM_WORLD,&size);
+ PetscPrintf(PETSC_COMM_WORLD,"Number of processors = %d\n",size);
+
/* - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - -
Compute the matrix and right-hand-side vector that define
the linear system, Ax = b.
*/
for (Ii=Istart; Ii<Iend; Ii++) {
v = -1.0; i = Ii/n; j = Ii - i*n;
- if (i>0) {J = Ii - n; ierr = MatSetValues(A,1,&Ii,1,&J,&v,INSERT_VALUES);CHKERRQ(ierr);}
+ PetscScalar v2=-1.;
+ if (i>0) {J = Ii - n; ierr = MatSetValues(A,1,&Ii,1,&J,&v2,INSERT_VALUES);CHKERRQ(ierr);}
if (i<m-1) {J = Ii + n; ierr = MatSetValues(A,1,&Ii,1,&J,&v,INSERT_VALUES);CHKERRQ(ierr);}
if (j>0) {J = Ii - 1; ierr = MatSetValues(A,1,&Ii,1,&J,&v,INSERT_VALUES);CHKERRQ(ierr);}
if (j<n-1) {J = Ii + 1; ierr = MatSetValues(A,1,&Ii,1,&J,&v,INSERT_VALUES);CHKERRQ(ierr);}
to set various options.
*/
ierr = KSPGetPC(ksp,&pc);CHKERRQ(ierr);
- ierr = KSPSetTolerances(ksp,1e-9,1e-9,PETSC_DEFAULT,5000000);CHKERRQ(ierr);
+ ierr = KSPSetTolerances(ksp,1e-7,1e-7,PETSC_DEFAULT,5000000);CHKERRQ(ierr);
+
+
+ // PC pc;
+ ierr = KSPSetFromOptions(ksp);CHKERRQ(ierr);
+ KSPGetPC(ksp, &pc);
+ PCType type;
+ PCGetType(pc, &type);
+
+ PetscPrintf(PETSC_COMM_WORLD, "PC TYPE %s \n", type);
+
/*
Set runtime options, e.g.,
- - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - */
PetscScalar T1,T2;
T1 = MPI_Wtime();
- ierr = KSPSolve(ksp,b,x);CHKERRQ(ierr);
+ ierr = KSPSolve(ksp,b,x);CHKERRQ(ierr);
T2 = MPI_Wtime();
/* - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - -
Check solution and clean up