mlprec/mld_daggrmat_raw_asb.F90
 mlprec/mld_daggrmat_smth_asb.F90
 mlprec/mld_das_aply.f90
 mlprec/mld_dbaseprec_aply.f90
 mlprec/mld_dbaseprec_bld.f90
 mlprec/mld_dilu0_fact.f90
 mlprec/mld_diluk_fact.f90
 mlprec/mld_dilut_fact.f90
 mlprec/mld_dmlprec_aply.f90
 mlprec/mld_dprec_aply.f90
 mlprec/mld_dprecbld.f90
 mlprec/mld_dprecinit.f90
 mlprec/mld_dprecset.f90
 mlprec/mld_dslu_bld.f90
 mlprec/mld_dslud_bld.f90
 mlprec/mld_dsub_aply.f90
 mlprec/mld_dsub_solve.f90
 mlprec/mld_dumf_bld.f90
 mlprec/mld_zaggrmat_raw_asb.F90
 mlprec/mld_zaggrmat_smth_asb.F90
 mlprec/mld_zas_aply.f90
 mlprec/mld_zbaseprec_aply.f90
 mlprec/mld_zbaseprec_bld.f90
 mlprec/mld_zilu0_fact.f90
 mlprec/mld_ziluk_fact.f90
 mlprec/mld_zilut_fact.f90
 mlprec/mld_zmlprec_aply.f90
 mlprec/mld_zprec_aply.f90
 mlprec/mld_zprecbld.f90
 mlprec/mld_zprecinit.f90
 mlprec/mld_zprecset.f90
 mlprec/mld_zslu_bld.f90
 mlprec/mld_zslud_bld.f90
 mlprec/mld_zsub_aply.f90
 mlprec/mld_zsub_solve.f90
 mlprec/mld_zumf_bld.f90
 test/fileread/df_bench.f90
 test/fileread/df_sample.f90
 test/pargen/ppde.f90

Fixed name of TOUPPER and friends with prefix PSB_.
stopcriterion
Salvatore Filippone 17 years ago
parent 338679aa63
commit 61460bde96

@ -178,7 +178,7 @@ subroutine mld_daggrmat_raw_asb(a,desc_a,ac,desc_ac,p,info)
goto 9999 goto 9999
end if end if
! Out from sp_clip is always in COO, but just in case.. ! Out from sp_clip is always in COO, but just in case..
if (tolower(b%fida) /= 'coo') then if (psb_tolower(b%fida) /= 'coo') then
call psb_errpush(4010,name,a_err='spclip NOT COO') call psb_errpush(4010,name,a_err='spclip NOT COO')
goto 9999 goto 9999
end if end if

@ -267,7 +267,7 @@ subroutine mld_daggrmat_smth_asb(a,desc_a,ac,desc_ac,p,info)
! !
! This only works with CSR. ! This only works with CSR.
! !
if (toupper(am3%fida)=='CSR') then if (psb_toupper(am3%fida)=='CSR') then
anorm = dzero anorm = dzero
dg = done dg = done
do i=1,am3%m do i=1,am3%m
@ -308,7 +308,7 @@ subroutine mld_daggrmat_smth_asb(a,desc_a,ac,desc_ac,p,info)
end if end if
if (toupper(am3%fida)=='CSR') then if (psb_toupper(am3%fida)=='CSR') then
do i=1,am3%m do i=1,am3%m
do j=am3%ia2(i),am3%ia2(i+1)-1 do j=am3%ia2(i),am3%ia2(i+1)-1
if (am3%ia1(j) == i) then if (am3%ia1(j) == i) then

@ -106,7 +106,7 @@ subroutine mld_das_aply(alpha,prec,x,beta,y,desc_data,trans,work,info)
call psb_info(ictxt, me, np) call psb_info(ictxt, me, np)
trans_ = toupper(trans) trans_ = psb_toupper(trans)
select case(prec%iprcparm(mld_prec_type_)) select case(prec%iprcparm(mld_prec_type_))

@ -110,7 +110,7 @@ subroutine mld_dbaseprec_aply(alpha,prec,x,beta,y,desc_data,trans,work,info)
call psb_info(ictxt, me, np) call psb_info(ictxt, me, np)
trans_= toupper(trans) trans_= psb_toupper(trans)
select case(trans_) select case(trans_)
case('N','T','C') case('N','T','C')
! Ok ! Ok

@ -109,8 +109,8 @@ subroutine mld_dbaseprc_bld(a,desc_a,p,info,upd)
if (present(upd)) then if (present(upd)) then
if (debug_level >= psb_debug_outer_) & if (debug_level >= psb_debug_outer_) &
& write(debug_unit,*) me,' ',trim(name),'UPD ', upd & write(debug_unit,*) me,' ',trim(name),'UPD ', upd
if ((toupper(UPD) == 'F').or.(toupper(UPD) == 'T')) then if ((psb_toupper(UPD) == 'F').or.(psb_toupper(UPD) == 'T')) then
IUPD=toupper(UPD) IUPD=psb_toupper(UPD)
else else
IUPD='F' IUPD='F'
endif endif

@ -569,7 +569,7 @@ contains
info=0 info=0
call psb_erractionsave(err_act) call psb_erractionsave(err_act)
if (toupper(a%fida)=='CSR') then if (psb_toupper(a%fida)=='CSR') then
! !
! Take a fast shortcut if the matrix is stored in CSR format ! Take a fast shortcut if the matrix is stored in CSR format

@ -507,7 +507,7 @@ contains
call psb_erractionsave(err_act) call psb_erractionsave(err_act)
call psb_init_heap(heap,info) call psb_init_heap(heap,info)
if (toupper(a%fida)=='CSR') then if (psb_toupper(a%fida)=='CSR') then
! !
! Take a fast shortcut if the matrix is stored in CSR format ! Take a fast shortcut if the matrix is stored in CSR format

@ -519,7 +519,7 @@ contains
dmaxup = dzero dmaxup = dzero
nrmi = dzero nrmi = dzero
if (toupper(a%fida)=='CSR') then if (psb_toupper(a%fida)=='CSR') then
! !
! Take a fast shortcut if the matrix is stored in CSR format ! Take a fast shortcut if the matrix is stored in CSR format

@ -200,7 +200,7 @@ subroutine mld_dmlprec_aply(alpha,baseprecv,x,beta,y,desc_data,trans,work,info)
& write(debug_unit,*) me,' ',trim(name),& & write(debug_unit,*) me,' ',trim(name),&
& ' Entry ', size(baseprecv) & ' Entry ', size(baseprecv)
trans_ = toupper(trans) trans_ = psb_toupper(trans)
select case(baseprecv(2)%iprcparm(mld_ml_type_)) select case(baseprecv(2)%iprcparm(mld_ml_type_))

@ -102,7 +102,7 @@ subroutine mld_dprec_aply(prec,x,y,desc_data,info,trans,work)
call psb_info(ictxt, me, np) call psb_info(ictxt, me, np)
if (present(trans)) then if (present(trans)) then
trans_=toupper(trans) trans_=psb_toupper(trans)
else else
trans_='N' trans_='N'
end if end if

@ -108,8 +108,8 @@ subroutine mld_dprecbld(a,desc_a,p,info)
!!$ if (debug_level >= psb_debug_outer_) & !!$ if (debug_level >= psb_debug_outer_) &
!!$ & write(debug_unit,*) me,' ',trim(name),'UPD ', upd !!$ & write(debug_unit,*) me,' ',trim(name),'UPD ', upd
!!$ !!$
!!$ if ((toupper(upd).eq.'F').or.(toupper(upd).eq.'T')) then !!$ if ((psb_toupper(upd).eq.'F').or.(psb_toupper(upd).eq.'T')) then
!!$ upd_=toupper(upd) !!$ upd_=psb_toupper(upd)
!!$ else !!$ else
!!$ upd_='F' !!$ upd_='F'
!!$ endif !!$ endif

@ -109,7 +109,7 @@ subroutine mld_dprecinit(p,ptype,info,nlev)
endif endif
endif endif
select case(toupper(ptype(1:len_trim(ptype)))) select case(psb_toupper(ptype(1:len_trim(ptype))))
case ('NONE','NOPREC') case ('NONE','NOPREC')
nlev_ = 1 nlev_ = 1
ilev_ = 1 ilev_ = 1

@ -436,7 +436,7 @@ contains
integer, intent(out) :: val, info integer, intent(out) :: val, info
info = 0 info = 0
select case(toupper(trim(string))) select case(psb_toupper(trim(string)))
case('NONE') case('NONE')
val = 0 val = 0
case('HALO') case('HALO')

@ -95,7 +95,7 @@ subroutine mld_dslu_bld(a,desc_a,p,info)
call psb_info(ictxt, me, np) call psb_info(ictxt, me, np)
if (toupper(a%fida) /= 'CSR') then if (psb_toupper(a%fida) /= 'CSR') then
info=135 info=135
call psb_errpush(info,name,a_err=a%fida) call psb_errpush(info,name,a_err=a%fida)
goto 9999 goto 9999

@ -93,7 +93,7 @@ subroutine mld_dsludist_bld(a,desc_a,p,info)
call psb_info(ictxt, me, np) call psb_info(ictxt, me, np)
if (toupper(a%fida) /= 'CSR') then if (psb_toupper(a%fida) /= 'CSR') then
info=135 info=135
call psb_errpush(info,name,a_err=a%fida) call psb_errpush(info,name,a_err=a%fida)
goto 9999 goto 9999

@ -163,7 +163,7 @@ subroutine mld_dsub_aply(alpha,prec,x,beta,y,desc_data,trans,work,info)
ictxt=psb_cd_get_context(desc_data) ictxt=psb_cd_get_context(desc_data)
call psb_info(ictxt, me, np) call psb_info(ictxt, me, np)
trans_ = toupper(trans) trans_ = psb_toupper(trans)
select case(trans_) select case(trans_)
case('N') case('N')
case('T','C') case('T','C')

@ -151,7 +151,7 @@ subroutine mld_dsub_solve(alpha,prec,x,beta,y,desc_data,trans,work,info)
ictxt=psb_cd_get_context(desc_data) ictxt=psb_cd_get_context(desc_data)
call psb_info(ictxt, me, np) call psb_info(ictxt, me, np)
trans_ = toupper(trans) trans_ = psb_toupper(trans)
select case(trans_) select case(trans_)
case('N') case('N')
case('T','C') case('T','C')

@ -99,7 +99,7 @@ subroutine mld_dumf_bld(a,desc_a,p,info)
ictxt = psb_cd_get_context(desc_a) ictxt = psb_cd_get_context(desc_a)
call psb_info(ictxt, me, np) call psb_info(ictxt, me, np)
if (toupper(a%fida) /= 'CSC') then if (psb_toupper(a%fida) /= 'CSC') then
info=135 info=135
call psb_errpush(info,name,a_err=a%fida) call psb_errpush(info,name,a_err=a%fida)
goto 9999 goto 9999

@ -178,7 +178,7 @@ subroutine mld_zaggrmat_raw_asb(a,desc_a,ac,desc_ac,p,info)
goto 9999 goto 9999
end if end if
! Out from sp_clip is always in COO, but just in case.. ! Out from sp_clip is always in COO, but just in case..
if (tolower(b%fida) /= 'coo') then if (psb_tolower(b%fida) /= 'coo') then
call psb_errpush(4010,name,a_err='spclip NOT COO') call psb_errpush(4010,name,a_err='spclip NOT COO')
goto 9999 goto 9999
end if end if

@ -267,7 +267,7 @@ subroutine mld_zaggrmat_smth_asb(a,desc_a,ac,desc_ac,p,info)
! !
! This only works with CSR. ! This only works with CSR.
! !
if (toupper(am3%fida)=='CSR') then if (psb_toupper(am3%fida)=='CSR') then
anorm = dzero anorm = dzero
dg = done dg = done
do i=1,am3%m do i=1,am3%m
@ -308,7 +308,7 @@ subroutine mld_zaggrmat_smth_asb(a,desc_a,ac,desc_ac,p,info)
end if end if
if (toupper(am3%fida)=='CSR') then if (psb_toupper(am3%fida)=='CSR') then
do i=1,am3%m do i=1,am3%m
do j=am3%ia2(i),am3%ia2(i+1)-1 do j=am3%ia2(i),am3%ia2(i+1)-1
if (am3%ia1(j) == i) then if (am3%ia1(j) == i) then

@ -106,7 +106,7 @@ subroutine mld_zas_aply(alpha,prec,x,beta,y,desc_data,trans,work,info)
call psb_info(ictxt, me, np) call psb_info(ictxt, me, np)
trans_ = toupper(trans) trans_ = psb_toupper(trans)
select case(prec%iprcparm(mld_prec_type_)) select case(prec%iprcparm(mld_prec_type_))

@ -110,7 +110,7 @@ subroutine mld_zbaseprec_aply(alpha,prec,x,beta,y,desc_data,trans,work,info)
call psb_info(ictxt, me, np) call psb_info(ictxt, me, np)
trans_= toupper(trans) trans_= psb_toupper(trans)
select case(trans_) select case(trans_)
case('N','T','C') case('N','T','C')
! Ok ! Ok

@ -109,8 +109,8 @@ subroutine mld_zbaseprc_bld(a,desc_a,p,info,upd)
if (present(upd)) then if (present(upd)) then
if (debug_level >= psb_debug_outer_) & if (debug_level >= psb_debug_outer_) &
& write(debug_unit,*) me,' ',trim(name),'UPD ', upd & write(debug_unit,*) me,' ',trim(name),'UPD ', upd
if ((toupper(UPD) == 'F').or.(toupper(UPD) == 'T')) then if ((psb_toupper(UPD) == 'F').or.(psb_toupper(UPD) == 'T')) then
IUPD=toupper(UPD) IUPD=psb_toupper(UPD)
else else
IUPD='F' IUPD='F'
endif endif

@ -569,7 +569,7 @@ contains
info=0 info=0
call psb_erractionsave(err_act) call psb_erractionsave(err_act)
if (toupper(a%fida)=='CSR') then if (psb_toupper(a%fida)=='CSR') then
! !
! Take a fast shortcut if the matrix is stored in CSR format ! Take a fast shortcut if the matrix is stored in CSR format

@ -508,7 +508,7 @@ contains
call psb_erractionsave(err_act) call psb_erractionsave(err_act)
call psb_init_heap(heap,info) call psb_init_heap(heap,info)
if (toupper(a%fida)=='CSR') then if (psb_toupper(a%fida)=='CSR') then
! !
! Take a fast shortcut if the matrix is stored in CSR format ! Take a fast shortcut if the matrix is stored in CSR format

@ -520,7 +520,7 @@ contains
dmaxup = dzero dmaxup = dzero
nrmi = dzero nrmi = dzero
if (toupper(a%fida)=='CSR') then if (psb_toupper(a%fida)=='CSR') then
! !
! Take a fast shortcut if the matrix is stored in CSR format ! Take a fast shortcut if the matrix is stored in CSR format

@ -200,7 +200,7 @@ subroutine mld_zmlprec_aply(alpha,baseprecv,x,beta,y,desc_data,trans,work,info)
& write(debug_unit,*) me,' ',trim(name),& & write(debug_unit,*) me,' ',trim(name),&
& ' Entry ', size(baseprecv) & ' Entry ', size(baseprecv)
trans_ = toupper(trans) trans_ = psb_toupper(trans)
select case(baseprecv(2)%iprcparm(mld_ml_type_)) select case(baseprecv(2)%iprcparm(mld_ml_type_))

@ -102,7 +102,7 @@ subroutine mld_zprec_aply(prec,x,y,desc_data,info,trans,work)
call psb_info(ictxt, me, np) call psb_info(ictxt, me, np)
if (present(trans)) then if (present(trans)) then
trans_=toupper(trans) trans_=psb_toupper(trans)
else else
trans_='N' trans_='N'
end if end if

@ -108,8 +108,8 @@ subroutine mld_zprecbld(a,desc_a,p,info)
!!$ if (debug_level >= psb_debug_outer_) & !!$ if (debug_level >= psb_debug_outer_) &
!!$ & write(debug_unit,*) me,' ',trim(name),'UPD ', upd !!$ & write(debug_unit,*) me,' ',trim(name),'UPD ', upd
!!$ !!$
!!$ if ((toupper(upd).eq.'F').or.(toupper(upd).eq.'T')) then !!$ if ((psb_toupper(upd).eq.'F').or.(psb_toupper(upd).eq.'T')) then
!!$ upd_=toupper(upd) !!$ upd_=psb_toupper(upd)
!!$ else !!$ else
!!$ upd_='F' !!$ upd_='F'
!!$ endif !!$ endif

@ -109,7 +109,7 @@ subroutine mld_zprecinit(p,ptype,info,nlev)
endif endif
endif endif
select case(toupper(ptype(1:len_trim(ptype)))) select case(psb_toupper(ptype(1:len_trim(ptype))))
case ('NONE','NOPREC') case ('NONE','NOPREC')
nlev_ = 1 nlev_ = 1
ilev_ = 1 ilev_ = 1

@ -436,7 +436,7 @@ contains
integer, intent(out) :: val, info integer, intent(out) :: val, info
info = 0 info = 0
select case(toupper(trim(string))) select case(psb_toupper(trim(string)))
case('NONE') case('NONE')
val = 0 val = 0
case('HALO') case('HALO')

@ -95,7 +95,7 @@ subroutine mld_zslu_bld(a,desc_a,p,info)
call psb_info(ictxt, me, np) call psb_info(ictxt, me, np)
if (toupper(a%fida) /= 'CSR') then if (psb_toupper(a%fida) /= 'CSR') then
info=135 info=135
call psb_errpush(info,name,a_err=a%fida) call psb_errpush(info,name,a_err=a%fida)
goto 9999 goto 9999

@ -93,7 +93,7 @@ subroutine mld_zsludist_bld(a,desc_a,p,info)
call psb_info(ictxt, me, np) call psb_info(ictxt, me, np)
if (toupper(a%fida) /= 'CSR') then if (psb_toupper(a%fida) /= 'CSR') then
info=135 info=135
call psb_errpush(info,name,a_err=a%fida) call psb_errpush(info,name,a_err=a%fida)
goto 9999 goto 9999

@ -164,7 +164,7 @@ subroutine mld_zsub_aply(alpha,prec,x,beta,y,desc_data,trans,work,info)
ictxt=psb_cd_get_context(desc_data) ictxt=psb_cd_get_context(desc_data)
call psb_info(ictxt, me, np) call psb_info(ictxt, me, np)
trans_ = toupper(trans) trans_ = psb_toupper(trans)
select case(trans_) select case(trans_)
case('N') case('N')
case('T','C') case('T','C')

@ -152,7 +152,7 @@ subroutine mld_zsub_solve(alpha,prec,x,beta,y,desc_data,trans,work,info)
ictxt=psb_cd_get_context(desc_data) ictxt=psb_cd_get_context(desc_data)
call psb_info(ictxt, me, np) call psb_info(ictxt, me, np)
trans_ = toupper(trans) trans_ = psb_toupper(trans)
select case(trans_) select case(trans_)
case('N') case('N')
case('T','C') case('T','C')

@ -99,7 +99,7 @@ subroutine mld_zumf_bld(a,desc_a,p,info)
ictxt = psb_cd_get_context(desc_a) ictxt = psb_cd_get_context(desc_a)
call psb_info(ictxt, me, np) call psb_info(ictxt, me, np)
if (toupper(a%fida) /= 'CSC') then if (psb_toupper(a%fida) /= 'CSC') then
info=135 info=135
call psb_errpush(info,name,a_err=a%fida) call psb_errpush(info,name,a_err=a%fida)
goto 9999 goto 9999

@ -377,7 +377,7 @@ program df_bench
write(0,'(" ")') write(0,'(" ")')
write(0,'("Saving x on file")') write(0,'("Saving x on file")')
write(outf3,'(a,a,a)')trim(mtrx(nm)),'.psb_sol.',& write(outf3,'(a,a,a)')trim(mtrx(nm)),'.psb_sol.',&
& tolower(trim(precs(pp)%descr)) & psb_tolower(trim(precs(pp)%descr))
open(20,file=outf3) open(20,file=outf3)
write(20,*) 'matrix: ',mtrx(nm) write(20,*) 'matrix: ',mtrx(nm)
write(20,*) 'computed solution on ',np,' processors.' write(20,*) 'computed solution on ',np,' processors.'

@ -266,7 +266,7 @@ program df_sample
! !
if (toupper(prec_choice%prec) =='ML') then if (psb_toupper(prec_choice%prec) =='ML') then
nlv = prec_choice%nlev nlv = prec_choice%nlev
else else
nlv = 1 nlv = 1
@ -278,7 +278,7 @@ program df_sample
call mld_precset(prec,mld_sub_solve_,prec_choice%solve,info) call mld_precset(prec,mld_sub_solve_,prec_choice%solve,info)
call mld_precset(prec,mld_sub_fill_in_,prec_choice%fill1,info) call mld_precset(prec,mld_sub_fill_in_,prec_choice%fill1,info)
call mld_precset(prec,mld_fact_thrs_,prec_choice%thr1,info) call mld_precset(prec,mld_fact_thrs_,prec_choice%thr1,info)
if (toupper(prec_choice%prec) =='ML') then if (psb_toupper(prec_choice%prec) =='ML') then
call mld_precset(prec,mld_aggr_kind_,prec_choice%aggrkind,info) call mld_precset(prec,mld_aggr_kind_,prec_choice%aggrkind,info)
call mld_precset(prec,mld_aggr_alg_,prec_choice%aggr_alg,info) call mld_precset(prec,mld_aggr_alg_,prec_choice%aggr_alg,info)
call mld_precset(prec,mld_ml_type_,prec_choice%mltype,info) call mld_precset(prec,mld_ml_type_,prec_choice%mltype,info)
@ -426,7 +426,7 @@ contains
call read_data(prec%solve,5) ! Factorization type: ILU, SuperLU, UMFPACK. call read_data(prec%solve,5) ! Factorization type: ILU, SuperLU, UMFPACK.
call read_data(prec%fill1,5) ! Fill-in for factorization 1 call read_data(prec%fill1,5) ! Fill-in for factorization 1
call read_data(prec%thr1,5) ! Threshold for fact. 1 ILU(T) call read_data(prec%thr1,5) ! Threshold for fact. 1 ILU(T)
if (toupper(prec%prec) == 'ML') then if (psb_toupper(prec%prec) == 'ML') then
call read_data(prec%nlev,5) ! Number of levels in multilevel prec. call read_data(prec%nlev,5) ! Number of levels in multilevel prec.
call read_data(prec%aggrkind,5) ! smoothed/raw aggregatin call read_data(prec%aggrkind,5) ! smoothed/raw aggregatin
call read_data(prec%aggr_alg,5) ! local or global aggregation call read_data(prec%aggr_alg,5) ! local or global aggregation
@ -460,7 +460,7 @@ contains
call psb_bcast(icontxt,prec%solve) ! Factorization type: ILU, SuperLU, UMFPACK. call psb_bcast(icontxt,prec%solve) ! Factorization type: ILU, SuperLU, UMFPACK.
call psb_bcast(icontxt,prec%fill1) ! Fill-in for factorization 1 call psb_bcast(icontxt,prec%fill1) ! Fill-in for factorization 1
call psb_bcast(icontxt,prec%thr1) ! Threshold for fact. 1 ILU(T) call psb_bcast(icontxt,prec%thr1) ! Threshold for fact. 1 ILU(T)
if (toupper(prec%prec) == 'ML') then if (psb_toupper(prec%prec) == 'ML') then
call psb_bcast(icontxt,prec%nlev) ! Number of levels in multilevel prec. call psb_bcast(icontxt,prec%nlev) ! Number of levels in multilevel prec.
call psb_bcast(icontxt,prec%aggrkind) ! smoothed/raw aggregatin call psb_bcast(icontxt,prec%aggrkind) ! smoothed/raw aggregatin
call psb_bcast(icontxt,prec%aggr_alg) ! local or global aggregation call psb_bcast(icontxt,prec%aggr_alg) ! local or global aggregation

@ -221,7 +221,7 @@ program ppde
! prepare the preconditioner. ! prepare the preconditioner.
! !
if (toupper(prectype%prec) =='ML') then if (psb_toupper(prectype%prec) =='ML') then
nlv = prectype%nlev nlv = prectype%nlev
else else
nlv = 1 nlv = 1
@ -233,7 +233,7 @@ program ppde
call mld_precset(prec,mld_sub_solve_,prectype%solve,info) call mld_precset(prec,mld_sub_solve_,prectype%solve,info)
call mld_precset(prec,mld_sub_fill_in_,prectype%fill1,info) call mld_precset(prec,mld_sub_fill_in_,prectype%fill1,info)
call mld_precset(prec,mld_fact_thrs_,prectype%thr1,info) call mld_precset(prec,mld_fact_thrs_,prectype%thr1,info)
if (toupper(prectype%prec) =='ML') then if (psb_toupper(prectype%prec) =='ML') then
call mld_precset(prec,mld_aggr_kind_,prectype%aggrkind,info) call mld_precset(prec,mld_aggr_kind_,prectype%aggrkind,info)
call mld_precset(prec,mld_aggr_alg_,prectype%aggr_alg,info) call mld_precset(prec,mld_aggr_alg_,prectype%aggr_alg,info)
call mld_precset(prec,mld_ml_type_,prectype%mltype,info) call mld_precset(prec,mld_ml_type_,prectype%mltype,info)
@ -352,7 +352,7 @@ contains
call read_data(prectype%solve,5) ! Factorization type: ILU, SuperLU, UMFPACK. call read_data(prectype%solve,5) ! Factorization type: ILU, SuperLU, UMFPACK.
call read_data(prectype%fill1,5) ! Fill-in for factorization 1 call read_data(prectype%fill1,5) ! Fill-in for factorization 1
call read_data(prectype%thr1,5) ! Threshold for fact. 1 ILU(T) call read_data(prectype%thr1,5) ! Threshold for fact. 1 ILU(T)
if (toupper(prectype%prec) == 'ML') then if (psb_toupper(prectype%prec) == 'ML') then
call read_data(prectype%nlev,5) ! Number of levels in multilevel prec. call read_data(prectype%nlev,5) ! Number of levels in multilevel prec.
call read_data(prectype%aggrkind,5) ! smoothed/raw aggregatin call read_data(prectype%aggrkind,5) ! smoothed/raw aggregatin
call read_data(prectype%aggr_alg,5) ! local or global aggregation call read_data(prectype%aggr_alg,5) ! local or global aggregation
@ -385,7 +385,7 @@ contains
call psb_bcast(ictxt,prectype%solve) ! Factorization type: ILU, SuperLU, UMFPACK. call psb_bcast(ictxt,prectype%solve) ! Factorization type: ILU, SuperLU, UMFPACK.
call psb_bcast(ictxt,prectype%fill1) ! Fill-in for factorization 1 call psb_bcast(ictxt,prectype%fill1) ! Fill-in for factorization 1
call psb_bcast(ictxt,prectype%thr1) ! Threshold for fact. 1 ILU(T) call psb_bcast(ictxt,prectype%thr1) ! Threshold for fact. 1 ILU(T)
if (toupper(prectype%prec) == 'ML') then if (psb_toupper(prectype%prec) == 'ML') then
call psb_bcast(ictxt,prectype%nlev) ! Number of levels in multilevel prec. call psb_bcast(ictxt,prectype%nlev) ! Number of levels in multilevel prec.
call psb_bcast(ictxt,prectype%aggrkind) ! smoothed/raw aggregatin call psb_bcast(ictxt,prectype%aggrkind) ! smoothed/raw aggregatin
call psb_bcast(ictxt,prectype%aggr_alg) ! local or global aggregation call psb_bcast(ictxt,prectype%aggr_alg) ! local or global aggregation

Loading…
Cancel
Save