|
|
@ -34,10 +34,53 @@
|
|
|
|
!!$ POSSIBILITY OF SUCH DAMAGE.
|
|
|
|
!!$ POSSIBILITY OF SUCH DAMAGE.
|
|
|
|
!!$
|
|
|
|
!!$
|
|
|
|
!!$
|
|
|
|
!!$
|
|
|
|
subroutine psb_dmlprc_aply(baseprecv,x,beta,y,desc_data,trans,work,info)
|
|
|
|
subroutine psb_dmlprc_aply(alpha,baseprecv,x,beta,y,desc_data,trans,work,info)
|
|
|
|
!
|
|
|
|
!
|
|
|
|
! Compute Y <- beta*Y + K^-1 X
|
|
|
|
! Compute Y <- beta*Y + alpha*K^-1 X
|
|
|
|
! where K is a multilevel (actually 2-level) preconditioner stored in prec
|
|
|
|
! where K is a multilevel preconditioner stored in baseprecv
|
|
|
|
|
|
|
|
!
|
|
|
|
|
|
|
|
! cfr.: Smith, Biorstad & Gropp
|
|
|
|
|
|
|
|
! Domain Decomposition
|
|
|
|
|
|
|
|
! Cambridge Univ. Press
|
|
|
|
|
|
|
|
!
|
|
|
|
|
|
|
|
! To each level I there corresponds a matrix A(I) and a preconditioner K(I)
|
|
|
|
|
|
|
|
!
|
|
|
|
|
|
|
|
! A notational difference: in the DD reference above the preconditioner for
|
|
|
|
|
|
|
|
! a given level K(I) is written out as a sum over the subdomains
|
|
|
|
|
|
|
|
!
|
|
|
|
|
|
|
|
! SUM_k(R_k^T A_k R_k)
|
|
|
|
|
|
|
|
!
|
|
|
|
|
|
|
|
! whereas in this code the sum is implicit in the parallelization,
|
|
|
|
|
|
|
|
! i.e. each process takes care of one subdomain, and for each level we have
|
|
|
|
|
|
|
|
! as many subdomains as there are processes (except for the coarsest level where
|
|
|
|
|
|
|
|
! we might have a replicated index space). Thus the sum apparently disappears
|
|
|
|
|
|
|
|
! from our code, but only apparently, because it is implicit in the call
|
|
|
|
|
|
|
|
! to psb_baseprc_aply.
|
|
|
|
|
|
|
|
!
|
|
|
|
|
|
|
|
! A bit of description of the baseprecv(:) data structure:
|
|
|
|
|
|
|
|
! 1. Number of levels = NLEV = size(baseprecv(:))
|
|
|
|
|
|
|
|
! 2. baseprecv(ilev)%av(:) sparse matrices needed for the current level.
|
|
|
|
|
|
|
|
! Includes:
|
|
|
|
|
|
|
|
! 2.1.: baseprecv(ilev)%av(l_pr_) L factor of ILU preconditioners
|
|
|
|
|
|
|
|
! 2.2.: baseprecv(ilev)%av(u_pr_) U factor of ILU preconditioners
|
|
|
|
|
|
|
|
! 2.3.: baseprecv(ilev)%av(ap_nd_) Off-diagonal part of A for Jacobi sweeps
|
|
|
|
|
|
|
|
! 2.4.: baseprecv(ilev)%av(ac_) Aggregated matrix of level ILEV
|
|
|
|
|
|
|
|
! 2.5.: baseprecv(ilev)%av(sm_pr_t_) Smoother prolongator transpose; maps vectors
|
|
|
|
|
|
|
|
! (ilev-1) ---> (ilev)
|
|
|
|
|
|
|
|
! 2.6.: baseprecv(ilev)%av(sm_pr_) Smoother prolongator; maps vectors
|
|
|
|
|
|
|
|
! (ilev) ---> (ilev-1)
|
|
|
|
|
|
|
|
! Shouldn't we keep just one of them and handle transpose in the sparse BLAS? maybe
|
|
|
|
|
|
|
|
!
|
|
|
|
|
|
|
|
! 3. baseprecv(ilev)%desc_data comm descriptor for level ILEV
|
|
|
|
|
|
|
|
! 4. baseprecv(ilev)%base_a Pointer (really a pointer!) to the base matrix
|
|
|
|
|
|
|
|
! of the current level, i.e.: if ILEV=1 then A
|
|
|
|
|
|
|
|
! else the aggregated matrix av(ac_); so we have
|
|
|
|
|
|
|
|
! a unified treatment of residuals. Need this to
|
|
|
|
|
|
|
|
! avoid passing explicitly matrix A to the
|
|
|
|
|
|
|
|
! outer prec. routine
|
|
|
|
|
|
|
|
! 5. baseprecv(ilev)%mlia The aggregation map from (ilev-1)-->(ilev)
|
|
|
|
|
|
|
|
! if no smoother, it is used instead of sm_pr_
|
|
|
|
|
|
|
|
! 6. baseprecv(ilev)%nlaggr Number of aggregates on the various procs.
|
|
|
|
!
|
|
|
|
!
|
|
|
|
|
|
|
|
|
|
|
|
use psb_serial_mod
|
|
|
|
use psb_serial_mod
|
|
|
@ -52,41 +95,49 @@ subroutine psb_dmlprc_aply(baseprecv,x,beta,y,desc_data,trans,work,info)
|
|
|
|
|
|
|
|
|
|
|
|
type(psb_desc_type),intent(in) :: desc_data
|
|
|
|
type(psb_desc_type),intent(in) :: desc_data
|
|
|
|
type(psb_dbaseprc_type), intent(in) :: baseprecv(:)
|
|
|
|
type(psb_dbaseprc_type), intent(in) :: baseprecv(:)
|
|
|
|
real(kind(0.d0)),intent(in) :: beta
|
|
|
|
real(kind(0.d0)),intent(in) :: alpha,beta
|
|
|
|
real(kind(0.d0)),intent(inout) :: x(:), y(:)
|
|
|
|
real(kind(0.d0)),intent(inout) :: x(:), y(:)
|
|
|
|
character :: trans
|
|
|
|
character :: trans
|
|
|
|
real(kind(0.d0)),target :: work(:)
|
|
|
|
real(kind(0.d0)),target :: work(:)
|
|
|
|
integer, intent(out) :: info
|
|
|
|
integer, intent(out) :: info
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
! Local variables
|
|
|
|
! Local variables
|
|
|
|
integer :: n_row,n_col
|
|
|
|
integer :: n_row,n_col
|
|
|
|
real(kind(1.d0)), allocatable :: tx(:),ty(:),t2l(:),w2l(:),&
|
|
|
|
real(kind(1.d0)), allocatable :: tx(:),ty(:),x2l(:),y2l(:),&
|
|
|
|
& x2l(:),b2l(:),tz(:),tty(:)
|
|
|
|
& b2l(:),tty(:)
|
|
|
|
character ::diagl, diagu
|
|
|
|
character ::diagl, diagu
|
|
|
|
integer :: ictxt,np,me,i, isz, nrg,nr2l,err_act, iptype, int_err(5)
|
|
|
|
integer :: ictxt,np,me,i, isz, nrg,nr2l,err_act, iptype, int_err(5)
|
|
|
|
real(kind(1.d0)) :: omega
|
|
|
|
real(kind(1.d0)) :: omega
|
|
|
|
real(kind(1.d0)) :: t1, t2, t3, t4, t5, t6, t7, mpi_wtime
|
|
|
|
real(kind(1.d0)) :: t1, t2, t3, t4, t5, t6, t7, mpi_wtime
|
|
|
|
logical, parameter :: debug=.false., debugprt=.false.
|
|
|
|
logical, parameter :: debug=.false., debugprt=.false.
|
|
|
|
integer :: ismth
|
|
|
|
integer :: ismth, nlev, ilev
|
|
|
|
external mpi_wtime
|
|
|
|
external mpi_wtime
|
|
|
|
character(len=20) :: name, ch_err
|
|
|
|
character(len=20) :: name, ch_err
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
type psb_mlprec_wrk_type
|
|
|
|
|
|
|
|
real(kind(1.d0)), pointer :: tx(:)=>null(),ty(:)=>null(),&
|
|
|
|
|
|
|
|
& x2l(:)=>null(),y2l(:)=>null(),&
|
|
|
|
|
|
|
|
& b2l(:)=>null(),tty(:)=>null()
|
|
|
|
|
|
|
|
end type psb_mlprec_wrk_type
|
|
|
|
|
|
|
|
type(psb_mlprec_wrk_type), pointer :: mlprec_wrk(:)
|
|
|
|
|
|
|
|
|
|
|
|
interface psb_baseprc_aply
|
|
|
|
interface psb_baseprc_aply
|
|
|
|
subroutine psb_dbaseprc_aply(prec,x,beta,y,desc_data,trans,work,info)
|
|
|
|
subroutine psb_dbaseprc_aply(alpha,prec,x,beta,y,desc_data,trans,work,info)
|
|
|
|
use psb_descriptor_type
|
|
|
|
use psb_descriptor_type
|
|
|
|
use psb_prec_type
|
|
|
|
use psb_prec_type
|
|
|
|
type(psb_desc_type),intent(in) :: desc_data
|
|
|
|
type(psb_desc_type),intent(in) :: desc_data
|
|
|
|
type(psb_dbaseprc_type), intent(in) :: prec
|
|
|
|
type(psb_dbaseprc_type), intent(in) :: prec
|
|
|
|
real(kind(0.d0)),intent(inout) :: x(:), y(:)
|
|
|
|
real(kind(0.d0)),intent(inout) :: x(:), y(:)
|
|
|
|
real(kind(0.d0)),intent(in) :: beta
|
|
|
|
real(kind(0.d0)),intent(in) :: alpha,beta
|
|
|
|
character(len=1) :: trans
|
|
|
|
character(len=1) :: trans
|
|
|
|
real(kind(0.d0)),target :: work(:)
|
|
|
|
real(kind(0.d0)),target :: work(:)
|
|
|
|
integer, intent(out) :: info
|
|
|
|
integer, intent(out) :: info
|
|
|
|
end subroutine psb_dbaseprc_aply
|
|
|
|
end subroutine psb_dbaseprc_aply
|
|
|
|
end interface
|
|
|
|
end interface
|
|
|
|
|
|
|
|
|
|
|
|
name='psb_dmlprc_aply'
|
|
|
|
name='psb_mlprc_aply'
|
|
|
|
info = 0
|
|
|
|
info = 0
|
|
|
|
call psb_erractionsave(err_act)
|
|
|
|
call psb_erractionsave(err_act)
|
|
|
|
|
|
|
|
|
|
|
@ -94,426 +145,625 @@ subroutine psb_dmlprc_aply(baseprecv,x,beta,y,desc_data,trans,work,info)
|
|
|
|
ictxt=desc_data%matrix_data(psb_ctxt_)
|
|
|
|
ictxt=desc_data%matrix_data(psb_ctxt_)
|
|
|
|
call psb_info(ictxt, me, np)
|
|
|
|
call psb_info(ictxt, me, np)
|
|
|
|
|
|
|
|
|
|
|
|
omega=baseprecv(2)%dprcparm(smooth_omega_)
|
|
|
|
nlev = size(baseprecv)
|
|
|
|
ismth=baseprecv(2)%iprcparm(smth_kind_)
|
|
|
|
allocate(mlprec_wrk(nlev),stat=info)
|
|
|
|
|
|
|
|
if (info /= 0) then
|
|
|
|
|
|
|
|
call psb_errpush(4010,name,a_err='Allocate')
|
|
|
|
|
|
|
|
goto 9999
|
|
|
|
|
|
|
|
end if
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
select case(baseprecv(2)%iprcparm(ml_type_))
|
|
|
|
select case(baseprecv(2)%iprcparm(ml_type_))
|
|
|
|
|
|
|
|
|
|
|
|
case(no_ml_)
|
|
|
|
case(no_ml_)
|
|
|
|
! Should not really get here.
|
|
|
|
! Should not really get here.
|
|
|
|
write(0,*) 'Smooth preconditioner with no multilevel in MLPRC_APLY????'
|
|
|
|
call psb_errpush(4010,name,a_err='no_ml_ in mlprc_aply?')
|
|
|
|
|
|
|
|
goto 9999
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
case(add_ml_prec_)
|
|
|
|
case(add_ml_prec_)
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
!
|
|
|
|
!
|
|
|
|
! Additive multilevel
|
|
|
|
! Additive is very simple.
|
|
|
|
|
|
|
|
! 1. X(1) = Xext
|
|
|
|
|
|
|
|
! 2. DO ILEV=2,NLEV
|
|
|
|
|
|
|
|
! X(ILEV) = AV(PR_SM_T_)*X(ILEV-1)
|
|
|
|
|
|
|
|
! 3. Y(ILEV) = (K(ILEV)**(-1))*X(ILEV)
|
|
|
|
|
|
|
|
! 4. DO ILEV=NLEV-1,1,-1
|
|
|
|
|
|
|
|
! Y(ILEV) = AV(PR_SM_)*Y(ILEV+1)
|
|
|
|
|
|
|
|
! 5. Yext = beta*Yext + Y(1)
|
|
|
|
!
|
|
|
|
!
|
|
|
|
t1 = mpi_wtime()
|
|
|
|
! Note: level numbering reversed wrt ref. DD, i.e.
|
|
|
|
n_row = desc_data%matrix_data(psb_n_row_)
|
|
|
|
! 1..NLEV <=> (j) <-> 0
|
|
|
|
n_col = baseprecv(1)%desc_data%matrix_data(psb_n_col_)
|
|
|
|
|
|
|
|
call psb_baseprc_aply(baseprecv(1),x,beta,y,desc_data,trans,work,info)
|
|
|
|
|
|
|
|
if(info /=0) goto 9999
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
nr2l = baseprecv(2)%desc_data%matrix_data(psb_n_col_)
|
|
|
|
call psb_baseprc_aply(alpha,baseprecv(1),x,beta,y,&
|
|
|
|
nrg = baseprecv(2)%desc_data%matrix_data(psb_n_row_)
|
|
|
|
& baseprecv(1)%base_desc,trans,work,info)
|
|
|
|
allocate(t2l(nr2l),w2l(nr2l),stat=info)
|
|
|
|
if(info /=0) goto 9999
|
|
|
|
|
|
|
|
allocate(mlprec_wrk(1)%x2l(size(x)),mlprec_wrk(1)%y2l(size(y)))
|
|
|
|
|
|
|
|
mlprec_wrk(1)%x2l(:) = x(:)
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
do ilev = 2, nlev
|
|
|
|
|
|
|
|
n_row = baseprecv(ilev-1)%base_desc%matrix_data(psb_n_row_)
|
|
|
|
|
|
|
|
n_col = baseprecv(ilev-1)%desc_data%matrix_data(psb_n_col_)
|
|
|
|
|
|
|
|
nr2l = baseprecv(ilev)%desc_data%matrix_data(psb_n_col_)
|
|
|
|
|
|
|
|
nrg = baseprecv(ilev)%desc_data%matrix_data(psb_n_row_)
|
|
|
|
|
|
|
|
allocate(mlprec_wrk(ilev)%x2l(nr2l),mlprec_wrk(ilev)%y2l(nr2l),&
|
|
|
|
|
|
|
|
& mlprec_wrk(ilev)%tx(max(n_row,n_col)),&
|
|
|
|
|
|
|
|
& mlprec_wrk(ilev)%ty(max(n_row,n_col)), stat=info)
|
|
|
|
if (info /= 0) then
|
|
|
|
if (info /= 0) then
|
|
|
|
call psb_errpush(4010,name,a_err='Allocate')
|
|
|
|
call psb_errpush(4010,name,a_err='Allocate')
|
|
|
|
goto 9999
|
|
|
|
goto 9999
|
|
|
|
end if
|
|
|
|
end if
|
|
|
|
|
|
|
|
|
|
|
|
t2l(:) = dzero
|
|
|
|
mlprec_wrk(ilev)%x2l(:) = dzero
|
|
|
|
w2l(:) = dzero
|
|
|
|
mlprec_wrk(ilev)%y2l(:) = dzero
|
|
|
|
|
|
|
|
mlprec_wrk(ilev)%tx(1:n_row) = mlprec_wrk(ilev-1)%x2l(1:n_row)
|
|
|
|
|
|
|
|
mlprec_wrk(ilev)%tx(n_row+1:max(n_row,n_col)) = dzero
|
|
|
|
|
|
|
|
mlprec_wrk(ilev)%ty(:) = dzero
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
ismth=baseprecv(ilev)%iprcparm(smth_kind_)
|
|
|
|
|
|
|
|
|
|
|
|
if (ismth /= no_smth_) then
|
|
|
|
if (ismth /= no_smth_) then
|
|
|
|
!
|
|
|
|
!
|
|
|
|
! Smoothed aggregation
|
|
|
|
! Smoothed aggregation
|
|
|
|
!
|
|
|
|
!
|
|
|
|
allocate(tx(max(n_row,n_col)),ty(max(n_row,n_col)),&
|
|
|
|
|
|
|
|
& tz(max(n_row,n_col)),stat=info)
|
|
|
|
|
|
|
|
if (info /= 0) then
|
|
|
|
|
|
|
|
call psb_errpush(4010,name,a_err='Allocate')
|
|
|
|
|
|
|
|
goto 9999
|
|
|
|
|
|
|
|
end if
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
tx(1:desc_data%matrix_data(psb_n_row_)) = x(1:desc_data%matrix_data(psb_n_row_))
|
|
|
|
|
|
|
|
tx(desc_data%matrix_data(psb_n_row_)+1:max(n_row,n_col)) = dzero
|
|
|
|
|
|
|
|
ty(desc_data%matrix_data(psb_n_row_)+1:max(n_row,n_col)) = dzero
|
|
|
|
|
|
|
|
tz(desc_data%matrix_data(psb_n_row_)+1:max(n_row,n_col)) = dzero
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
if (baseprecv(2)%iprcparm(glb_smth_) >0) then
|
|
|
|
if (baseprecv(ilev)%iprcparm(glb_smth_) >0) then
|
|
|
|
call psb_halo(tx,desc_data,info,work=work)
|
|
|
|
call psb_halo(mlprec_wrk(ilev-1)%x2l,baseprecv(ilev-1)%base_desc,&
|
|
|
|
|
|
|
|
& info,work=work)
|
|
|
|
if(info /=0) goto 9999
|
|
|
|
if(info /=0) goto 9999
|
|
|
|
else
|
|
|
|
else
|
|
|
|
tx(desc_data%matrix_data(psb_n_row_)+1:max(n_row,n_col)) = dzero
|
|
|
|
mlprec_wrk(ilev-1)%x2l(n_row+1:max(n_row,n_col)) = dzero
|
|
|
|
end if
|
|
|
|
end if
|
|
|
|
|
|
|
|
|
|
|
|
call psb_csmm(done,baseprecv(2)%av(sm_pr_t_),tx,dzero,t2l,info)
|
|
|
|
call psb_csmm(done,baseprecv(ilev)%av(sm_pr_t_),mlprec_wrk(ilev-1)%x2l,&
|
|
|
|
|
|
|
|
& dzero,mlprec_wrk(ilev)%x2l,info)
|
|
|
|
if(info /=0) goto 9999
|
|
|
|
if(info /=0) goto 9999
|
|
|
|
|
|
|
|
|
|
|
|
else
|
|
|
|
else
|
|
|
|
!
|
|
|
|
!
|
|
|
|
! Raw aggregation, may take shortcut
|
|
|
|
! Raw aggregation, may take shortcut
|
|
|
|
!
|
|
|
|
!
|
|
|
|
do i=1,desc_data%matrix_data(psb_n_row_)
|
|
|
|
do i=1,n_row
|
|
|
|
t2l(baseprecv(2)%mlia(i)) = t2l(baseprecv(2)%mlia(i)) + x(i)
|
|
|
|
mlprec_wrk(ilev)%x2l(baseprecv(ilev)%mlia(i)) = &
|
|
|
|
|
|
|
|
& mlprec_wrk(ilev)%x2l(baseprecv(ilev)%mlia(i)) + &
|
|
|
|
|
|
|
|
& mlprec_wrk(ilev-1)%x2l(i)
|
|
|
|
end do
|
|
|
|
end do
|
|
|
|
|
|
|
|
|
|
|
|
end if
|
|
|
|
end if
|
|
|
|
|
|
|
|
|
|
|
|
if (baseprecv(2)%iprcparm(coarse_mat_)==mat_repl_) Then
|
|
|
|
if (baseprecv(ilev)%iprcparm(coarse_mat_)==mat_repl_) Then
|
|
|
|
call psb_sum(ictxt,t2l(1:nrg))
|
|
|
|
call psb_sum(ictxt,mlprec_wrk(ilev)%x2l(1:nrg))
|
|
|
|
else if (baseprecv(2)%iprcparm(coarse_mat_) /= mat_distr_) Then
|
|
|
|
else if (baseprecv(ilev)%iprcparm(coarse_mat_) /= mat_distr_) Then
|
|
|
|
write(0,*) 'Unknown value for baseprecv(2)%iprcparm(coarse_mat_) ',&
|
|
|
|
write(0,*) 'Unknown value for baseprecv(2)%iprcparm(coarse_mat_) ',&
|
|
|
|
& baseprecv(2)%iprcparm(coarse_mat_)
|
|
|
|
& baseprecv(ilev)%iprcparm(coarse_mat_)
|
|
|
|
endif
|
|
|
|
endif
|
|
|
|
|
|
|
|
|
|
|
|
w2l=t2l
|
|
|
|
call psb_baseprc_aply(done,baseprecv(ilev),&
|
|
|
|
call psb_baseprc_aply(baseprecv(2),w2l,dzero,t2l,baseprecv(2)%desc_data,&
|
|
|
|
& mlprec_wrk(ilev)%x2l,dzero,mlprec_wrk(ilev)%y2l,&
|
|
|
|
& 'N',work,info)
|
|
|
|
& baseprecv(ilev)%desc_data, 'N',work,info)
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
enddo
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
do ilev =nlev,2,-1
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
ismth=baseprecv(ilev)%iprcparm(smth_kind_)
|
|
|
|
|
|
|
|
n_row = baseprecv(ilev-1)%base_desc%matrix_data(psb_n_row_)
|
|
|
|
|
|
|
|
n_col = baseprecv(ilev-1)%desc_data%matrix_data(psb_n_col_)
|
|
|
|
|
|
|
|
nr2l = baseprecv(ilev)%desc_data%matrix_data(psb_n_col_)
|
|
|
|
|
|
|
|
nrg = baseprecv(ilev)%desc_data%matrix_data(psb_n_row_)
|
|
|
|
|
|
|
|
|
|
|
|
if (ismth /= no_smth_) then
|
|
|
|
if (ismth /= no_smth_) then
|
|
|
|
|
|
|
|
|
|
|
|
call psb_csmm(done,baseprecv(2)%av(sm_pr_),t2l,dzero,ty,info)
|
|
|
|
call psb_csmm(done,baseprecv(ilev)%av(sm_pr_),mlprec_wrk(ilev)%y2l,&
|
|
|
|
|
|
|
|
& done,mlprec_wrk(ilev-1)%y2l,info)
|
|
|
|
if(info /=0) goto 9999
|
|
|
|
if(info /=0) goto 9999
|
|
|
|
!
|
|
|
|
|
|
|
|
! Finally add back into Y.
|
|
|
|
|
|
|
|
!
|
|
|
|
|
|
|
|
call psb_geaxpby(done,ty,done,y,desc_data,info)
|
|
|
|
|
|
|
|
if(info /=0) goto 9999
|
|
|
|
|
|
|
|
deallocate(tx,ty,tz)
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
else
|
|
|
|
else
|
|
|
|
|
|
|
|
|
|
|
|
do i=1, desc_data%matrix_data(psb_n_row_)
|
|
|
|
do i=1, n_row
|
|
|
|
y(i) = y(i) + t2l(baseprecv(2)%mlia(i))
|
|
|
|
mlprec_wrk(ilev-1)%y2l(i) = mlprec_wrk(ilev-1)%y2l(i) + &
|
|
|
|
|
|
|
|
& mlprec_wrk(ilev)%y2l(baseprecv(ilev)%mlia(i))
|
|
|
|
enddo
|
|
|
|
enddo
|
|
|
|
|
|
|
|
|
|
|
|
end if
|
|
|
|
end if
|
|
|
|
|
|
|
|
end do
|
|
|
|
|
|
|
|
|
|
|
|
if (debugprt) write(0,*)' Y2: ',Y(:)
|
|
|
|
call psb_geaxpby(alpha,mlprec_wrk(1)%y2l,done,y,baseprecv(1)%base_desc,info)
|
|
|
|
|
|
|
|
if(info /=0) goto 9999
|
|
|
|
|
|
|
|
|
|
|
|
deallocate(t2l,w2l)
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
case(mult_ml_prec_)
|
|
|
|
case(mult_ml_prec_)
|
|
|
|
|
|
|
|
|
|
|
|
!
|
|
|
|
!
|
|
|
|
! Multiplicative multilevel
|
|
|
|
! Multiplicative multilevel
|
|
|
|
! Pre/post smoothing versions.
|
|
|
|
! Pre/post smoothing versions.
|
|
|
|
|
|
|
|
!
|
|
|
|
|
|
|
|
|
|
|
|
select case(baseprecv(2)%iprcparm(smth_pos_))
|
|
|
|
select case(baseprecv(2)%iprcparm(smth_pos_))
|
|
|
|
|
|
|
|
|
|
|
|
case(post_smooth_)
|
|
|
|
case(post_smooth_)
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
t1 = mpi_wtime()
|
|
|
|
|
|
|
|
n_row = desc_data%matrix_data(psb_n_row_)
|
|
|
|
|
|
|
|
n_col = baseprecv(1)%desc_data%matrix_data(psb_n_col_)
|
|
|
|
|
|
|
|
nr2l = baseprecv(2)%desc_data%matrix_data(psb_n_col_)
|
|
|
|
|
|
|
|
nrg = baseprecv(2)%desc_data%matrix_data(psb_n_row_)
|
|
|
|
|
|
|
|
allocate(t2l(nr2l),w2l(nr2l),tx(n_col),ty(n_col),stat=info)
|
|
|
|
|
|
|
|
if (info /= 0) then
|
|
|
|
|
|
|
|
call psb_errpush(4010,name,a_err='Allocate')
|
|
|
|
|
|
|
|
goto 9999
|
|
|
|
|
|
|
|
end if
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
t2l(:) = dzero
|
|
|
|
|
|
|
|
w2l(:) = dzero
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
!
|
|
|
|
!
|
|
|
|
! Need temp copies to handle Y<- betaY + K^-1 X
|
|
|
|
! Post smoothing.
|
|
|
|
! One of the temp copies is not strictly needed when beta==dzero
|
|
|
|
! 1. X(1) = Xext
|
|
|
|
|
|
|
|
! 2. DO ILEV=2, NLEV :: X(ILEV) = AV(PR_SM_T_,ILEV)*X(ILEV-1)
|
|
|
|
|
|
|
|
! 3. Y(NLEV) = (K(NLEV)**(-1))*X(NLEV)
|
|
|
|
|
|
|
|
! 4. DO ILEV=NLEV-1,1,-1
|
|
|
|
|
|
|
|
! Y(ILEV) = AV(PR_SM_,ILEV+1)*Y(ILEV+1)
|
|
|
|
|
|
|
|
! Y(ILEV) = Y(ILEV) + (K(ILEV)**(-1))*(X(ILEV)-A(ILEV)*Y(ILEV))
|
|
|
|
|
|
|
|
!
|
|
|
|
|
|
|
|
! 5. Yext = beta*Yext + Y(1)
|
|
|
|
|
|
|
|
!
|
|
|
|
|
|
|
|
! Note: level numbering reversed wrt ref. DD, i.e.
|
|
|
|
|
|
|
|
! 1..NLEV <=> (j) <-> 0
|
|
|
|
|
|
|
|
!
|
|
|
|
|
|
|
|
! Also: post smoothing is not spelled out in detail in DD.
|
|
|
|
!
|
|
|
|
!
|
|
|
|
|
|
|
|
!
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
n_col = desc_data%matrix_data(psb_n_col_)
|
|
|
|
|
|
|
|
nr2l = baseprecv(1)%desc_data%matrix_data(psb_n_col_)
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
allocate(mlprec_wrk(1)%x2l(nr2l),mlprec_wrk(1)%y2l(nr2l), &
|
|
|
|
|
|
|
|
& mlprec_wrk(1)%tx(nr2l), stat=info)
|
|
|
|
|
|
|
|
mlprec_wrk(1)%x2l(:) = dzero
|
|
|
|
|
|
|
|
mlprec_wrk(1)%y2l(:) = dzero
|
|
|
|
|
|
|
|
mlprec_wrk(1)%tx(:) = dzero
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
call psb_geaxpby(done,x,dzero,mlprec_wrk(1)%tx,&
|
|
|
|
|
|
|
|
& baseprecv(1)%base_desc,info)
|
|
|
|
|
|
|
|
call psb_geaxpby(done,x,dzero,mlprec_wrk(1)%x2l,&
|
|
|
|
|
|
|
|
& baseprecv(1)%base_desc,info)
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
do ilev=2, nlev
|
|
|
|
|
|
|
|
n_row = baseprecv(ilev-1)%base_desc%matrix_data(psb_n_row_)
|
|
|
|
|
|
|
|
n_col = baseprecv(ilev-1)%desc_data%matrix_data(psb_n_col_)
|
|
|
|
|
|
|
|
nr2l = baseprecv(ilev)%desc_data%matrix_data(psb_n_col_)
|
|
|
|
|
|
|
|
nrg = baseprecv(ilev)%desc_data%matrix_data(psb_n_row_)
|
|
|
|
|
|
|
|
ismth = baseprecv(ilev)%iprcparm(smth_kind_)
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
allocate(mlprec_wrk(ilev)%tx(nr2l),mlprec_wrk(ilev)%y2l(nr2l),&
|
|
|
|
|
|
|
|
& mlprec_wrk(ilev)%x2l(nr2l), stat=info)
|
|
|
|
|
|
|
|
|
|
|
|
if (debug) write(0,*)' mult_ml_apply omega ',omega
|
|
|
|
|
|
|
|
if (debugprt) write(0,*)' mult_ml_apply X: ',X(:)
|
|
|
|
|
|
|
|
call psb_geaxpby(done,x,dzero,tx,desc_data,info)
|
|
|
|
|
|
|
|
if (info /= 0) then
|
|
|
|
if (info /= 0) then
|
|
|
|
if (debug) write(0,*)' From axpby1 ',size(x),size(tx),n_row,n_col,nr2l,nrg
|
|
|
|
call psb_errpush(4010,name,a_err='Allocate')
|
|
|
|
call psb_errpush(4010,name,a_err='axpby post_smooth 1')
|
|
|
|
|
|
|
|
goto 9999
|
|
|
|
goto 9999
|
|
|
|
end if
|
|
|
|
end if
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
mlprec_wrk(ilev)%x2l(:) = dzero
|
|
|
|
|
|
|
|
mlprec_wrk(ilev)%y2l(:) = dzero
|
|
|
|
|
|
|
|
mlprec_wrk(ilev)%tx(:) = dzero
|
|
|
|
if (ismth /= no_smth_) then
|
|
|
|
if (ismth /= no_smth_) then
|
|
|
|
!
|
|
|
|
!
|
|
|
|
! Smoothed aggregation
|
|
|
|
! Smoothed aggregation
|
|
|
|
!
|
|
|
|
!
|
|
|
|
allocate(tz(max(n_row,n_col)),stat=info)
|
|
|
|
if (baseprecv(ilev)%iprcparm(glb_smth_) >0) then
|
|
|
|
if (info /= 0) then
|
|
|
|
call psb_halo(mlprec_wrk(ilev-1)%x2l,&
|
|
|
|
call psb_errpush(4010,name,a_err='Allocate')
|
|
|
|
& baseprecv(ilev-1)%base_desc,info,work=work)
|
|
|
|
goto 9999
|
|
|
|
|
|
|
|
end if
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
if (baseprecv(2)%iprcparm(glb_smth_) >0) then
|
|
|
|
|
|
|
|
call psb_halo(tx,desc_data,info,work=work)
|
|
|
|
|
|
|
|
if(info /=0) goto 9999
|
|
|
|
if(info /=0) goto 9999
|
|
|
|
else
|
|
|
|
else
|
|
|
|
tx(desc_data%matrix_data(psb_n_row_)+1:max(n_row,n_col)) = dzero
|
|
|
|
mlprec_wrk(ilev-1)%x2l(n_row+1:max(n_row,n_col)) = dzero
|
|
|
|
end if
|
|
|
|
end if
|
|
|
|
|
|
|
|
|
|
|
|
call psb_csmm(done,baseprecv(2)%av(sm_pr_t_),tx,dzero,t2l,info)
|
|
|
|
call psb_csmm(done,baseprecv(ilev)%av(sm_pr_t_),mlprec_wrk(ilev-1)%x2l, &
|
|
|
|
|
|
|
|
& dzero,mlprec_wrk(ilev)%x2l,info)
|
|
|
|
if(info /=0) goto 9999
|
|
|
|
if(info /=0) goto 9999
|
|
|
|
|
|
|
|
|
|
|
|
else
|
|
|
|
else
|
|
|
|
!
|
|
|
|
!
|
|
|
|
! Raw aggregation, may take shortcut
|
|
|
|
! Raw aggregation, may take shortcut
|
|
|
|
!
|
|
|
|
!
|
|
|
|
do i=1,desc_data%matrix_data(psb_n_row_)
|
|
|
|
do i=1,n_row
|
|
|
|
t2l(baseprecv(2)%mlia(i)) = t2l(baseprecv(2)%mlia(i)) + tx(i)
|
|
|
|
mlprec_wrk(ilev)%x2l(baseprecv(ilev)%mlia(i)) = &
|
|
|
|
|
|
|
|
& mlprec_wrk(ilev)%x2l(baseprecv(ilev)%mlia(i)) + &
|
|
|
|
|
|
|
|
& mlprec_wrk(ilev-1)%x2l(i)
|
|
|
|
end do
|
|
|
|
end do
|
|
|
|
end if
|
|
|
|
end if
|
|
|
|
|
|
|
|
|
|
|
|
if (baseprecv(2)%iprcparm(coarse_mat_)==mat_repl_) Then
|
|
|
|
if (baseprecv(ilev)%iprcparm(coarse_mat_)==mat_repl_) Then
|
|
|
|
call psb_sum(ictxt,t2l(1:nrg))
|
|
|
|
call psb_sum(ictxt,mlprec_wrk(ilev)%x2l(1:nrg))
|
|
|
|
else if (baseprecv(2)%iprcparm(coarse_mat_) /= mat_distr_) Then
|
|
|
|
else if (baseprecv(ilev)%iprcparm(coarse_mat_) /= mat_distr_) Then
|
|
|
|
write(0,*) 'Unknown value for baseprecv(2)%iprcparm(coarse_mat_) ',&
|
|
|
|
write(0,*) 'Unknown value for baseprecv(2)%iprcparm(coarse_mat_) ',&
|
|
|
|
& baseprecv(2)%iprcparm(coarse_mat_)
|
|
|
|
& baseprecv(ilev)%iprcparm(coarse_mat_)
|
|
|
|
endif
|
|
|
|
endif
|
|
|
|
|
|
|
|
call psb_geaxpby(done,mlprec_wrk(ilev)%x2l,dzero,mlprec_wrk(ilev)%tx,&
|
|
|
|
|
|
|
|
& baseprecv(ilev)%base_desc,info)
|
|
|
|
|
|
|
|
if(info /=0) goto 9999
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
enddo
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
call psb_baseprc_aply(done,baseprecv(nlev),mlprec_wrk(nlev)%x2l, &
|
|
|
|
|
|
|
|
& dzero, mlprec_wrk(nlev)%y2l,baseprecv(nlev)%desc_data,'N',work,info)
|
|
|
|
|
|
|
|
|
|
|
|
t6 = mpi_wtime()
|
|
|
|
|
|
|
|
w2l=t2l
|
|
|
|
|
|
|
|
call psb_baseprc_aply(baseprecv(2),w2l,dzero,t2l,baseprecv(2)%desc_data,&
|
|
|
|
|
|
|
|
&'N',work,info)
|
|
|
|
|
|
|
|
if(info /=0) goto 9999
|
|
|
|
if(info /=0) goto 9999
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
do ilev=nlev-1, 1, -1
|
|
|
|
|
|
|
|
ismth = baseprecv(ilev+1)%iprcparm(smth_kind_)
|
|
|
|
if (ismth /= no_smth_) then
|
|
|
|
if (ismth /= no_smth_) then
|
|
|
|
if (ismth == smth_omg_) &
|
|
|
|
if (ismth == smth_omg_) &
|
|
|
|
& call psb_halo(t2l,baseprecv(2)%desc_data,info,work=work)
|
|
|
|
& call psb_halo(mlprec_wrk(ilev+1)%y2l,baseprecv(ilev+1)%desc_data,&
|
|
|
|
call psb_csmm(done,baseprecv(2)%av(sm_pr_),t2l,dzero,ty,info)
|
|
|
|
& info,work=work)
|
|
|
|
|
|
|
|
call psb_csmm(done,baseprecv(ilev+1)%av(sm_pr_),mlprec_wrk(ilev+1)%y2l,&
|
|
|
|
|
|
|
|
& dzero,mlprec_wrk(ilev)%y2l,info)
|
|
|
|
if(info /=0) goto 9999
|
|
|
|
if(info /=0) goto 9999
|
|
|
|
!
|
|
|
|
|
|
|
|
! Finally add back into Y.
|
|
|
|
|
|
|
|
!
|
|
|
|
|
|
|
|
deallocate(tz)
|
|
|
|
|
|
|
|
else
|
|
|
|
else
|
|
|
|
ty(:) = dzero
|
|
|
|
n_row = baseprecv(ilev)%base_desc%matrix_data(psb_n_row_)
|
|
|
|
do i=1, desc_data%matrix_data(psb_n_row_)
|
|
|
|
mlprec_wrk(ilev)%y2l(:) = dzero
|
|
|
|
ty(i) = ty(i) + t2l(baseprecv(2)%mlia(i))
|
|
|
|
do i=1, n_row
|
|
|
|
|
|
|
|
mlprec_wrk(ilev)%y2l(i) = mlprec_wrk(ilev)%y2l(i) + &
|
|
|
|
|
|
|
|
& mlprec_wrk(ilev+1)%y2l(baseprecv(ilev+1)%mlia(i))
|
|
|
|
enddo
|
|
|
|
enddo
|
|
|
|
|
|
|
|
|
|
|
|
end if
|
|
|
|
end if
|
|
|
|
deallocate(t2l,w2l)
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
call psb_spmm(-done,baseprecv(2)%aorig,ty,done,tx,desc_data,info,work=work)
|
|
|
|
call psb_spmm(-done,baseprecv(ilev)%base_a,mlprec_wrk(ilev)%y2l,&
|
|
|
|
if(info /=0) goto 9999
|
|
|
|
& done,mlprec_wrk(ilev)%tx,baseprecv(ilev)%base_desc,info,work=work)
|
|
|
|
|
|
|
|
|
|
|
|
call psb_baseprc_aply(baseprecv(1),tx,done,ty,desc_data,trans,&
|
|
|
|
|
|
|
|
& work,info)
|
|
|
|
|
|
|
|
if(info /=0) goto 9999
|
|
|
|
if(info /=0) goto 9999
|
|
|
|
|
|
|
|
|
|
|
|
call psb_geaxpby(done,ty,beta,y,desc_data,info)
|
|
|
|
call psb_baseprc_aply(done,baseprecv(ilev),mlprec_wrk(ilev)%tx,&
|
|
|
|
|
|
|
|
& done,mlprec_wrk(ilev)%y2l,baseprecv(ilev)%base_desc, trans, work,info)
|
|
|
|
|
|
|
|
|
|
|
|
if(info /=0) goto 9999
|
|
|
|
if(info /=0) goto 9999
|
|
|
|
|
|
|
|
|
|
|
|
deallocate(tx,ty)
|
|
|
|
enddo
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
call psb_geaxpby(alpha,mlprec_wrk(1)%y2l,beta,y,baseprecv(1)%base_desc,info)
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
if(info /=0) goto 9999
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
case(pre_smooth_)
|
|
|
|
case(pre_smooth_)
|
|
|
|
|
|
|
|
|
|
|
|
t1 = mpi_wtime()
|
|
|
|
|
|
|
|
n_row = desc_data%matrix_data(psb_n_row_)
|
|
|
|
!
|
|
|
|
n_col = baseprecv(1)%desc_data%matrix_data(psb_n_col_)
|
|
|
|
! Pre smoothing.
|
|
|
|
nr2l = baseprecv(2)%desc_data%matrix_data(psb_n_col_)
|
|
|
|
! 1. X(1) = Xext
|
|
|
|
nrg = baseprecv(2)%desc_data%matrix_data(psb_n_row_)
|
|
|
|
! 2. Y(1) = (K(1)**(-1))*X(1)
|
|
|
|
allocate(t2l(nr2l),w2l(nr2l),tx(n_col),ty(n_col),tty(n_col),stat=info)
|
|
|
|
! 3. TX(1) = X(1) - A(1)*Y(1)
|
|
|
|
|
|
|
|
! 4. DO ILEV=2, NLEV
|
|
|
|
|
|
|
|
! X(ILEV) = AV(PR_SM_T_,ILEV)*TX(ILEV-1)
|
|
|
|
|
|
|
|
! Y(ILEV) = (K(ILEV)**(-1))*X(ILEV)
|
|
|
|
|
|
|
|
! TX(ILEV) = (X(ILEV)-A(ILEV)*Y(ILEV))
|
|
|
|
|
|
|
|
! 5. DO ILEV=NLEV-1,1,-1
|
|
|
|
|
|
|
|
! Y(ILEV) = Y(ILEV) + AV(PR_SM_,ILEV+1)*Y(ILEV+1)
|
|
|
|
|
|
|
|
! 6. Yext = beta*Yext + Y(1)
|
|
|
|
|
|
|
|
!
|
|
|
|
|
|
|
|
! Note: level numbering reversed wrt ref. DD, i.e.
|
|
|
|
|
|
|
|
! 1..NLEV <=> (j) <-> 0
|
|
|
|
|
|
|
|
!
|
|
|
|
|
|
|
|
!
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
n_col = desc_data%matrix_data(psb_n_col_)
|
|
|
|
|
|
|
|
nr2l = baseprecv(1)%desc_data%matrix_data(psb_n_col_)
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
allocate(mlprec_wrk(1)%x2l(nr2l),mlprec_wrk(1)%y2l(nr2l), &
|
|
|
|
|
|
|
|
& mlprec_wrk(1)%tx(nr2l), stat=info)
|
|
|
|
if (info /= 0) then
|
|
|
|
if (info /= 0) then
|
|
|
|
call psb_errpush(4010,name,a_err='Allocate')
|
|
|
|
call psb_errpush(4010,name,a_err='Allocate')
|
|
|
|
goto 9999
|
|
|
|
goto 9999
|
|
|
|
end if
|
|
|
|
end if
|
|
|
|
|
|
|
|
|
|
|
|
t2l(:) = dzero
|
|
|
|
mlprec_wrk(1)%y2l(:) = dzero
|
|
|
|
w2l(:) = dzero
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
!
|
|
|
|
|
|
|
|
! Need temp copies to handle Y<- betaY + K^-1 X
|
|
|
|
|
|
|
|
! One of the temp copies is not strictly needed when beta==zero
|
|
|
|
|
|
|
|
!
|
|
|
|
|
|
|
|
call psb_geaxpby(done,x,dzero,tx,desc_data,info)
|
|
|
|
|
|
|
|
call psb_geaxpby(done,y,dzero,ty,desc_data,info)
|
|
|
|
|
|
|
|
if(info /=0) goto 9999
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
call psb_baseprc_aply(baseprecv(1),x,dzero,tty,desc_data,&
|
|
|
|
mlprec_wrk(1)%x2l(:) = x
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
call psb_baseprc_aply(done,baseprecv(1),mlprec_wrk(1)%x2l,&
|
|
|
|
|
|
|
|
& dzero,mlprec_wrk(1)%y2l,&
|
|
|
|
|
|
|
|
& baseprecv(1)%base_desc,&
|
|
|
|
& trans,work,info)
|
|
|
|
& trans,work,info)
|
|
|
|
|
|
|
|
|
|
|
|
if(info /=0) goto 9999
|
|
|
|
if(info /=0) goto 9999
|
|
|
|
|
|
|
|
|
|
|
|
call psb_spmm(-done,baseprecv(2)%aorig,tty,done,tx,desc_data,info,work=work)
|
|
|
|
mlprec_wrk(1)%tx = mlprec_wrk(1)%x2l
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
call psb_spmm(-done,baseprecv(1)%base_a,mlprec_wrk(1)%y2l,&
|
|
|
|
|
|
|
|
& done,mlprec_wrk(1)%tx,baseprecv(1)%base_desc,info,work=work)
|
|
|
|
if(info /=0) goto 9999
|
|
|
|
if(info /=0) goto 9999
|
|
|
|
|
|
|
|
|
|
|
|
if (ismth /= no_smth_) then
|
|
|
|
do ilev = 2, nlev
|
|
|
|
allocate(tz(max(n_row,n_col)),stat=info)
|
|
|
|
n_row = baseprecv(ilev-1)%base_desc%matrix_data(psb_n_row_)
|
|
|
|
|
|
|
|
n_col = baseprecv(ilev-1)%desc_data%matrix_data(psb_n_col_)
|
|
|
|
|
|
|
|
nr2l = baseprecv(ilev)%desc_data%matrix_data(psb_n_col_)
|
|
|
|
|
|
|
|
nrg = baseprecv(ilev)%desc_data%matrix_data(psb_n_row_)
|
|
|
|
|
|
|
|
ismth = baseprecv(ilev)%iprcparm(smth_kind_)
|
|
|
|
|
|
|
|
allocate(mlprec_wrk(ilev)%tx(nr2l),mlprec_wrk(ilev)%y2l(nr2l),&
|
|
|
|
|
|
|
|
& mlprec_wrk(ilev)%x2l(nr2l), stat=info)
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
if (info /= 0) then
|
|
|
|
if (info /= 0) then
|
|
|
|
call psb_errpush(4010,name,a_err='Allocate')
|
|
|
|
call psb_errpush(4010,name,a_err='Allocate')
|
|
|
|
goto 9999
|
|
|
|
goto 9999
|
|
|
|
end if
|
|
|
|
end if
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
mlprec_wrk(ilev)%x2l(:) = dzero
|
|
|
|
|
|
|
|
mlprec_wrk(ilev)%y2l(:) = dzero
|
|
|
|
|
|
|
|
mlprec_wrk(ilev)%tx(:) = dzero
|
|
|
|
|
|
|
|
|
|
|
|
if (baseprecv(2)%iprcparm(glb_smth_) >0) then
|
|
|
|
|
|
|
|
call psb_halo(tx,desc_data,info,work=work)
|
|
|
|
if (ismth /= no_smth_) then
|
|
|
|
|
|
|
|
!
|
|
|
|
|
|
|
|
!Smoothed Aggregation
|
|
|
|
|
|
|
|
!
|
|
|
|
|
|
|
|
if (baseprecv(ilev)%iprcparm(glb_smth_) >0) then
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
call psb_halo(mlprec_wrk(ilev-1)%tx,baseprecv(ilev-1)%base_desc,&
|
|
|
|
|
|
|
|
& info,work=work)
|
|
|
|
if(info /=0) goto 9999
|
|
|
|
if(info /=0) goto 9999
|
|
|
|
else
|
|
|
|
else
|
|
|
|
tx(desc_data%matrix_data(psb_n_row_)+1:max(n_row,n_col)) = dzero
|
|
|
|
mlprec_wrk(ilev-1)%tx(n_row+1:max(n_row,n_col)) = dzero
|
|
|
|
end if
|
|
|
|
end if
|
|
|
|
|
|
|
|
|
|
|
|
call psb_csmm(done,baseprecv(2)%av(sm_pr_t_),tx,dzero,t2l,info)
|
|
|
|
call psb_csmm(done,baseprecv(ilev)%av(sm_pr_t_),mlprec_wrk(ilev-1)%tx,dzero,&
|
|
|
|
|
|
|
|
& mlprec_wrk(ilev)%x2l,info)
|
|
|
|
if(info /=0) goto 9999
|
|
|
|
if(info /=0) goto 9999
|
|
|
|
|
|
|
|
|
|
|
|
else
|
|
|
|
else
|
|
|
|
!
|
|
|
|
!
|
|
|
|
! Raw aggregation, may take shortcuts
|
|
|
|
! Raw aggregation, may take shortcuts
|
|
|
|
!
|
|
|
|
!
|
|
|
|
do i=1,desc_data%matrix_data(psb_n_row_)
|
|
|
|
mlprec_wrk(ilev)%x2l = dzero
|
|
|
|
t2l(baseprecv(2)%mlia(i)) = t2l(baseprecv(2)%mlia(i)) + tx(i)
|
|
|
|
do i=1,n_row
|
|
|
|
|
|
|
|
mlprec_wrk(ilev)%x2l(baseprecv(ilev)%mlia(i)) = &
|
|
|
|
|
|
|
|
& mlprec_wrk(ilev)%x2l(baseprecv(ilev)%mlia(i)) + &
|
|
|
|
|
|
|
|
& mlprec_wrk(ilev-1)%tx(i)
|
|
|
|
end do
|
|
|
|
end do
|
|
|
|
end if
|
|
|
|
end if
|
|
|
|
|
|
|
|
|
|
|
|
if (baseprecv(2)%iprcparm(coarse_mat_)==mat_repl_) Then
|
|
|
|
if (baseprecv(ilev)%iprcparm(coarse_mat_)==mat_repl_) then
|
|
|
|
call psb_sum(ictxt,t2l(1:nrg))
|
|
|
|
call psb_sum(ictxt,mlprec_wrk(ilev)%x2l(1:nrg))
|
|
|
|
else if (baseprecv(2)%iprcparm(coarse_mat_) /= mat_distr_) Then
|
|
|
|
else if (baseprecv(ilev)%iprcparm(coarse_mat_) /= mat_distr_) then
|
|
|
|
write(0,*) 'Unknown value for baseprecv(2)%iprcparm(coarse_mat_) ',&
|
|
|
|
write(0,*) 'Unknown value for baseprecv(2)%iprcparm(coarse_mat_) ',&
|
|
|
|
& baseprecv(2)%iprcparm(coarse_mat_)
|
|
|
|
& baseprecv(ilev)%iprcparm(coarse_mat_)
|
|
|
|
endif
|
|
|
|
endif
|
|
|
|
|
|
|
|
|
|
|
|
t6 = mpi_wtime()
|
|
|
|
|
|
|
|
w2l=t2l
|
|
|
|
call psb_baseprc_aply(done,baseprecv(ilev),mlprec_wrk(ilev)%x2l,&
|
|
|
|
call psb_baseprc_aply(baseprecv(2),w2l,dzero,t2l,baseprecv(2)%desc_data,&
|
|
|
|
& dzero,mlprec_wrk(ilev)%y2l,baseprecv(ilev)%desc_data, 'N',work,info)
|
|
|
|
& 'N',work,info)
|
|
|
|
|
|
|
|
if(info /=0) goto 9999
|
|
|
|
if(info /=0) goto 9999
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
if(ilev < nlev) then
|
|
|
|
|
|
|
|
mlprec_wrk(ilev)%tx = mlprec_wrk(ilev)%x2l
|
|
|
|
|
|
|
|
call psb_spmm(-done,baseprecv(ilev)%base_a,mlprec_wrk(ilev)%y2l,&
|
|
|
|
|
|
|
|
& done,mlprec_wrk(ilev)%tx,baseprecv(ilev)%base_desc,info,work=work)
|
|
|
|
|
|
|
|
if(info /=0) goto 9999
|
|
|
|
|
|
|
|
endif
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
enddo
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
do ilev = nlev-1, 1, -1
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
ismth=baseprecv(ilev+1)%iprcparm(smth_kind_)
|
|
|
|
|
|
|
|
|
|
|
|
if (ismth /= no_smth_) then
|
|
|
|
if (ismth /= no_smth_) then
|
|
|
|
|
|
|
|
|
|
|
|
if (ismth == smth_omg_) &
|
|
|
|
if (ismth == smth_omg_) &
|
|
|
|
& call psb_halo(t2l,baseprecv(2)%desc_data,info,work=work)
|
|
|
|
& call psb_halo(mlprec_wrk(ilev+1)%y2l,&
|
|
|
|
call psb_csmm(done,baseprecv(2)%av(sm_pr_),t2l,dzero,ty,info)
|
|
|
|
& baseprecv(ilev+1)%desc_data,info,work=work)
|
|
|
|
if(info /=0) goto 9999
|
|
|
|
call psb_csmm(done,baseprecv(ilev+1)%av(sm_pr_),mlprec_wrk(ilev+1)%y2l,&
|
|
|
|
|
|
|
|
& done,mlprec_wrk(ilev)%y2l,info)
|
|
|
|
|
|
|
|
|
|
|
|
call psb_geaxpby(done,ty,done,tty,desc_data,info)
|
|
|
|
|
|
|
|
if(info /=0) goto 9999
|
|
|
|
if(info /=0) goto 9999
|
|
|
|
|
|
|
|
|
|
|
|
deallocate(tz)
|
|
|
|
|
|
|
|
else
|
|
|
|
else
|
|
|
|
|
|
|
|
|
|
|
|
do i=1, desc_data%matrix_data(psb_n_row_)
|
|
|
|
n_row = baseprecv(ilev+1)%base_desc%matrix_data(psb_n_row_)
|
|
|
|
tty(i) = tty(i) + t2l(baseprecv(2)%mlia(i))
|
|
|
|
do i=1, n_row
|
|
|
|
|
|
|
|
mlprec_wrk(ilev)%y2l(i) = mlprec_wrk(ilev)%y2l(i) + &
|
|
|
|
|
|
|
|
& mlprec_wrk(ilev+1)%y2l(baseprecv(ilev+1)%mlia(i))
|
|
|
|
enddo
|
|
|
|
enddo
|
|
|
|
|
|
|
|
|
|
|
|
end if
|
|
|
|
end if
|
|
|
|
|
|
|
|
|
|
|
|
call psb_geaxpby(done,tty,beta,y,desc_data,info)
|
|
|
|
enddo
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
call psb_geaxpby(alpha,mlprec_wrk(1)%y2l,beta,y,&
|
|
|
|
|
|
|
|
& baseprecv(1)%base_desc,info)
|
|
|
|
|
|
|
|
|
|
|
|
if(info /=0) goto 9999
|
|
|
|
if(info /=0) goto 9999
|
|
|
|
|
|
|
|
|
|
|
|
deallocate(t2l,w2l,tx,ty,tty)
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
case(smooth_both_)
|
|
|
|
case(smooth_both_)
|
|
|
|
|
|
|
|
|
|
|
|
t1 = mpi_wtime()
|
|
|
|
!
|
|
|
|
n_row = desc_data%matrix_data(psb_n_row_)
|
|
|
|
! Symmetrized smoothing.
|
|
|
|
n_col = baseprecv(1)%desc_data%matrix_data(psb_n_col_)
|
|
|
|
! 1. X(1) = Xext
|
|
|
|
nr2l = baseprecv(2)%desc_data%matrix_data(psb_n_col_)
|
|
|
|
! 2. Y(1) = (K(1)**(-1))*X(1)
|
|
|
|
nrg = baseprecv(2)%desc_data%matrix_data(psb_n_row_)
|
|
|
|
! 3. TX(1) = X(1) - A(1)*Y(1)
|
|
|
|
allocate(t2l(nr2l),w2l(nr2l),tx(n_col),ty(n_col),tty(n_col),stat=info)
|
|
|
|
! 4. DO ILEV=2, NLEV
|
|
|
|
|
|
|
|
! X(ILEV) = AV(PR_SM_T_,ILEV)*TX(ILEV-1)
|
|
|
|
|
|
|
|
! Y(ILEV) = (K(ILEV)**(-1))*X(ILEV)
|
|
|
|
|
|
|
|
! TX(ILEV) = (X(ILEV)-A(ILEV)*Y(ILEV))
|
|
|
|
|
|
|
|
! 5. DO ILEV=NLEV-1,1,-1
|
|
|
|
|
|
|
|
! Y(ILEV) = Y(ILEV) + AV(PR_SM_,ILEV+1)*Y(ILEV+1)
|
|
|
|
|
|
|
|
! Y(ILEV) = Y(ILEV) + (K(ILEV)**(-1))*(X(ILEV)-A(ILEV)*Y(ILEV))
|
|
|
|
|
|
|
|
! 6. Yext = beta*Yext + Y(1)
|
|
|
|
|
|
|
|
!
|
|
|
|
|
|
|
|
! Note: level numbering reversed wrt ref. DD, i.e.
|
|
|
|
|
|
|
|
! 1..NLEV <=> (j) <-> 0
|
|
|
|
|
|
|
|
!
|
|
|
|
|
|
|
|
!
|
|
|
|
|
|
|
|
n_col = desc_data%matrix_data(psb_n_col_)
|
|
|
|
|
|
|
|
nr2l = baseprecv(1)%desc_data%matrix_data(psb_n_col_)
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
allocate(mlprec_wrk(1)%x2l(nr2l),mlprec_wrk(1)%y2l(nr2l), &
|
|
|
|
|
|
|
|
& mlprec_wrk(1)%ty(nr2l), mlprec_wrk(1)%tx(nr2l), stat=info)
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
mlprec_wrk(1)%x2l(:) = dzero
|
|
|
|
|
|
|
|
mlprec_wrk(1)%y2l(:) = dzero
|
|
|
|
|
|
|
|
mlprec_wrk(1)%tx(:) = dzero
|
|
|
|
|
|
|
|
mlprec_wrk(1)%ty(:) = dzero
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
if (info /= 0) then
|
|
|
|
if (info /= 0) then
|
|
|
|
call psb_errpush(4010,name,a_err='Allocate')
|
|
|
|
call psb_errpush(4010,name,a_err='Allocate')
|
|
|
|
goto 9999
|
|
|
|
goto 9999
|
|
|
|
end if
|
|
|
|
end if
|
|
|
|
|
|
|
|
|
|
|
|
t2l(:) = dzero
|
|
|
|
call psb_geaxpby(done,x,dzero,mlprec_wrk(1)%x2l,&
|
|
|
|
w2l(:) = dzero
|
|
|
|
& baseprecv(1)%base_desc,info)
|
|
|
|
tx(:) = dzero
|
|
|
|
call psb_geaxpby(done,x,dzero,mlprec_wrk(1)%tx,&
|
|
|
|
ty(:) = dzero
|
|
|
|
& baseprecv(1)%base_desc,info)
|
|
|
|
tty(:) = dzero
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
!
|
|
|
|
call psb_baseprc_aply(done,baseprecv(1),mlprec_wrk(1)%x2l,&
|
|
|
|
! Need temp copies to handle Y<- betaY + K^-1 X
|
|
|
|
& dzero,mlprec_wrk(1)%y2l,&
|
|
|
|
! One of the temp copies is not strictly needed when beta==zero
|
|
|
|
& baseprecv(1)%base_desc,&
|
|
|
|
!
|
|
|
|
& trans,work,info)
|
|
|
|
call psb_geaxpby(done,x,dzero,tx,desc_data,info)
|
|
|
|
|
|
|
|
call psb_geaxpby(done,y,dzero,ty,desc_data,info)
|
|
|
|
|
|
|
|
if(info /=0) goto 9999
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
call psb_baseprc_aply(baseprecv(1),tx,dzero,tty,desc_data,trans,work,info)
|
|
|
|
|
|
|
|
if(info /=0) goto 9999
|
|
|
|
if(info /=0) goto 9999
|
|
|
|
|
|
|
|
|
|
|
|
call psb_spmm(-done,baseprecv(2)%aorig,tty,done,tx,desc_data,info,work=work)
|
|
|
|
mlprec_wrk(1)%ty = mlprec_wrk(1)%x2l
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
call psb_spmm(-done,baseprecv(1)%base_a,mlprec_wrk(1)%y2l,&
|
|
|
|
|
|
|
|
& done,mlprec_wrk(1)%ty,baseprecv(1)%base_desc,info,work=work)
|
|
|
|
if(info /=0) goto 9999
|
|
|
|
if(info /=0) goto 9999
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
do ilev = 2, nlev
|
|
|
|
|
|
|
|
n_row = baseprecv(ilev-1)%base_desc%matrix_data(psb_n_row_)
|
|
|
|
|
|
|
|
n_col = baseprecv(ilev-1)%desc_data%matrix_data(psb_n_col_)
|
|
|
|
|
|
|
|
nr2l = baseprecv(ilev)%desc_data%matrix_data(psb_n_col_)
|
|
|
|
|
|
|
|
nrg = baseprecv(ilev)%desc_data%matrix_data(psb_n_row_)
|
|
|
|
|
|
|
|
ismth=baseprecv(ilev)%iprcparm(smth_kind_)
|
|
|
|
|
|
|
|
allocate(mlprec_wrk(ilev)%ty(nr2l),mlprec_wrk(ilev)%y2l(nr2l),&
|
|
|
|
|
|
|
|
& mlprec_wrk(ilev)%x2l(nr2l), stat=info)
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
mlprec_wrk(ilev)%x2l(:) = dzero
|
|
|
|
|
|
|
|
mlprec_wrk(ilev)%y2l(:) = dzero
|
|
|
|
|
|
|
|
mlprec_wrk(ilev)%tx(:) = dzero
|
|
|
|
|
|
|
|
mlprec_wrk(ilev)%ty(:) = dzero
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
if (info /= 0) then
|
|
|
|
|
|
|
|
call psb_errpush(4010,name,a_err='Allocate')
|
|
|
|
|
|
|
|
goto 9999
|
|
|
|
|
|
|
|
end if
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
if (ismth /= no_smth_) then
|
|
|
|
if (ismth /= no_smth_) then
|
|
|
|
if (baseprecv(2)%iprcparm(glb_smth_) >0) then
|
|
|
|
!
|
|
|
|
call psb_halo(tx,baseprecv(1)%desc_data,info,work=work)
|
|
|
|
!Smoothed Aggregation
|
|
|
|
|
|
|
|
!
|
|
|
|
|
|
|
|
if (baseprecv(ilev)%iprcparm(glb_smth_) >0) then
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
call psb_halo(mlprec_wrk(ilev-1)%ty,baseprecv(ilev-1)%base_desc,&
|
|
|
|
|
|
|
|
& info,work=work)
|
|
|
|
if(info /=0) goto 9999
|
|
|
|
if(info /=0) goto 9999
|
|
|
|
else
|
|
|
|
else
|
|
|
|
tx(desc_data%matrix_data(psb_n_row_)+1:max(n_row,n_col)) = dzero
|
|
|
|
mlprec_wrk(ilev-1)%ty(n_row+1:max(n_row,n_col)) = dzero
|
|
|
|
end if
|
|
|
|
end if
|
|
|
|
|
|
|
|
|
|
|
|
call psb_csmm(done,baseprecv(2)%av(sm_pr_t_),tx,dzero,t2l,info)
|
|
|
|
call psb_csmm(done,baseprecv(ilev)%av(sm_pr_t_),mlprec_wrk(ilev-1)%ty,dzero,&
|
|
|
|
|
|
|
|
& mlprec_wrk(ilev)%x2l,info)
|
|
|
|
if(info /=0) goto 9999
|
|
|
|
if(info /=0) goto 9999
|
|
|
|
|
|
|
|
|
|
|
|
else
|
|
|
|
else
|
|
|
|
!
|
|
|
|
!
|
|
|
|
! Raw aggregation, may take shortcuts
|
|
|
|
! Raw aggregation, may take shortcuts
|
|
|
|
!
|
|
|
|
!
|
|
|
|
do i=1,desc_data%matrix_data(psb_n_row_)
|
|
|
|
mlprec_wrk(ilev)%x2l = dzero
|
|
|
|
t2l(baseprecv(2)%mlia(i)) = t2l(baseprecv(2)%mlia(i)) + tx(i)
|
|
|
|
do i=1,n_row
|
|
|
|
|
|
|
|
mlprec_wrk(ilev)%x2l(baseprecv(ilev)%mlia(i)) = &
|
|
|
|
|
|
|
|
& mlprec_wrk(ilev)%x2l(baseprecv(ilev)%mlia(i)) + &
|
|
|
|
|
|
|
|
& mlprec_wrk(ilev-1)%ty(i)
|
|
|
|
end do
|
|
|
|
end do
|
|
|
|
end if
|
|
|
|
end if
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
if (baseprecv(ilev)%iprcparm(coarse_mat_)==mat_repl_) then
|
|
|
|
if (baseprecv(2)%iprcparm(coarse_mat_)==mat_repl_) Then
|
|
|
|
call psb_sum(ictxt,mlprec_wrk(ilev)%x2l(1:nrg))
|
|
|
|
call psb_sum(ictxt,t2l(1:nrg))
|
|
|
|
else if (baseprecv(ilev)%iprcparm(coarse_mat_) /= mat_distr_) then
|
|
|
|
else if (baseprecv(2)%iprcparm(coarse_mat_) /= mat_distr_) Then
|
|
|
|
|
|
|
|
write(0,*) 'Unknown value for baseprecv(2)%iprcparm(coarse_mat_) ',&
|
|
|
|
write(0,*) 'Unknown value for baseprecv(2)%iprcparm(coarse_mat_) ',&
|
|
|
|
& baseprecv(2)%iprcparm(coarse_mat_)
|
|
|
|
& baseprecv(ilev)%iprcparm(coarse_mat_)
|
|
|
|
endif
|
|
|
|
endif
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
call psb_geaxpby(done,mlprec_wrk(ilev)%x2l,dzero,mlprec_wrk(ilev)%tx,&
|
|
|
|
t6 = mpi_wtime()
|
|
|
|
& baseprecv(ilev)%base_desc,info)
|
|
|
|
w2l=t2l
|
|
|
|
|
|
|
|
call psb_baseprc_aply(baseprecv(2),w2l,dzero,t2l,baseprecv(2)%desc_data,&
|
|
|
|
|
|
|
|
& 'N',work,info)
|
|
|
|
|
|
|
|
if(info /=0) goto 9999
|
|
|
|
if(info /=0) goto 9999
|
|
|
|
|
|
|
|
|
|
|
|
if (ismth /= no_smth_) then
|
|
|
|
call psb_baseprc_aply(done,baseprecv(ilev),mlprec_wrk(ilev)%x2l,&
|
|
|
|
|
|
|
|
& dzero,mlprec_wrk(ilev)%y2l,baseprecv(ilev)%desc_data, 'N',work,info)
|
|
|
|
|
|
|
|
|
|
|
|
if (ismth == smth_omg_) &
|
|
|
|
|
|
|
|
& call psb_halo(t2l,baseprecv(2)%desc_data,info,work=work)
|
|
|
|
|
|
|
|
call psb_csmm(done,baseprecv(2)%av(sm_pr_),t2l,dzero,ty,info)
|
|
|
|
|
|
|
|
if(info /=0) goto 9999
|
|
|
|
if(info /=0) goto 9999
|
|
|
|
|
|
|
|
|
|
|
|
call psb_geaxpby(done,ty,done,tty,desc_data,info)
|
|
|
|
if(ilev < nlev) then
|
|
|
|
|
|
|
|
mlprec_wrk(ilev)%ty = mlprec_wrk(ilev)%x2l
|
|
|
|
|
|
|
|
call psb_spmm(-done,baseprecv(ilev)%base_a,mlprec_wrk(ilev)%y2l,&
|
|
|
|
|
|
|
|
& done,mlprec_wrk(ilev)%ty,baseprecv(ilev)%base_desc,info,work=work)
|
|
|
|
if(info /=0) goto 9999
|
|
|
|
if(info /=0) goto 9999
|
|
|
|
|
|
|
|
endif
|
|
|
|
|
|
|
|
|
|
|
|
else
|
|
|
|
enddo
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
do ilev=nlev-1, 1, -1
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
ismth=baseprecv(ilev+1)%iprcparm(smth_kind_)
|
|
|
|
|
|
|
|
if (ismth /= no_smth_) then
|
|
|
|
|
|
|
|
if (ismth == smth_omg_) &
|
|
|
|
|
|
|
|
& call psb_halo(mlprec_wrk(ilev+1)%y2l,baseprecv(ilev+1)%desc_data,&
|
|
|
|
|
|
|
|
& info,work=work)
|
|
|
|
|
|
|
|
call psb_csmm(done,baseprecv(ilev+1)%av(sm_pr_),mlprec_wrk(ilev+1)%y2l,&
|
|
|
|
|
|
|
|
& done,mlprec_wrk(ilev)%y2l,info)
|
|
|
|
|
|
|
|
if(info /=0) goto 9999
|
|
|
|
|
|
|
|
|
|
|
|
do i=1, desc_data%matrix_data(psb_n_row_)
|
|
|
|
else
|
|
|
|
tty(i) = tty(i) + t2l(baseprecv(2)%mlia(i))
|
|
|
|
n_row = baseprecv(ilev)%base_desc%matrix_data(psb_n_row_)
|
|
|
|
|
|
|
|
do i=1, n_row
|
|
|
|
|
|
|
|
mlprec_wrk(ilev)%y2l(i) = mlprec_wrk(ilev)%y2l(i) + &
|
|
|
|
|
|
|
|
& mlprec_wrk(ilev+1)%y2l(baseprecv(ilev+1)%mlia(i))
|
|
|
|
enddo
|
|
|
|
enddo
|
|
|
|
|
|
|
|
|
|
|
|
end if
|
|
|
|
end if
|
|
|
|
|
|
|
|
|
|
|
|
call psb_geaxpby(done,x,dzero,tx,desc_data,info)
|
|
|
|
call psb_spmm(-done,baseprecv(ilev)%base_a,mlprec_wrk(ilev)%y2l,&
|
|
|
|
|
|
|
|
& done,mlprec_wrk(ilev)%tx,baseprecv(ilev)%base_desc,info,work=work)
|
|
|
|
|
|
|
|
|
|
|
|
if(info /=0) goto 9999
|
|
|
|
if(info /=0) goto 9999
|
|
|
|
|
|
|
|
|
|
|
|
call psb_spmm(-done,baseprecv(2)%aorig,tty,done,tx,desc_data,info,work=work)
|
|
|
|
call psb_baseprc_aply(done,baseprecv(ilev),mlprec_wrk(ilev)%tx,&
|
|
|
|
|
|
|
|
& done,mlprec_wrk(ilev)%y2l,baseprecv(ilev)%base_desc, trans, work,info)
|
|
|
|
|
|
|
|
|
|
|
|
if(info /=0) goto 9999
|
|
|
|
if(info /=0) goto 9999
|
|
|
|
call psb_baseprc_aply(baseprecv(1),tx,done,tty,desc_data,'N',work,info)
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
enddo
|
|
|
|
|
|
|
|
|
|
|
|
call psb_geaxpby(done,tty,beta,y,desc_data,info)
|
|
|
|
call psb_geaxpby(alpha,mlprec_wrk(1)%y2l,beta,y,&
|
|
|
|
|
|
|
|
& baseprecv(1)%base_desc,info)
|
|
|
|
|
|
|
|
|
|
|
|
deallocate(t2l,w2l,tx,ty,tty)
|
|
|
|
if(info /=0) goto 9999
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
case default
|
|
|
|
case default
|
|
|
|
|
|
|
|
|
|
|
|
write(0,*) 'Unknown value for ml_smooth_pos',baseprecv(2)%iprcparm(smth_pos_)
|
|
|
|
call psb_errpush(4013,name,a_err='wrong smooth_pos',&
|
|
|
|
|
|
|
|
& i_Err=(/baseprecv(2)%iprcparm(smth_pos_),0,0,0,0/))
|
|
|
|
|
|
|
|
goto 9999
|
|
|
|
|
|
|
|
|
|
|
|
end select
|
|
|
|
end select
|
|
|
|
|
|
|
|
|
|
|
|
case default
|
|
|
|
case default
|
|
|
|
write(0,*) me, 'Wrong mltype into PRC_APLY ',&
|
|
|
|
call psb_errpush(4013,name,a_err='wrong mltype',&
|
|
|
|
& baseprecv(2)%iprcparm(ml_type_)
|
|
|
|
& i_Err=(/baseprecv(2)%iprcparm(ml_type_),0,0,0,0/))
|
|
|
|
|
|
|
|
goto 9999
|
|
|
|
|
|
|
|
|
|
|
|
end select
|
|
|
|
end select
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
call mlprec_wrk_free(mlprec_wrk)
|
|
|
|
|
|
|
|
deallocate(mlprec_wrk)
|
|
|
|
|
|
|
|
|
|
|
|
call psb_erractionrestore(err_act)
|
|
|
|
call psb_erractionrestore(err_act)
|
|
|
|
return
|
|
|
|
return
|
|
|
|
|
|
|
|
|
|
|
@ -526,4 +776,24 @@ subroutine psb_dmlprc_aply(baseprecv,x,beta,y,desc_data,trans,work,info)
|
|
|
|
end if
|
|
|
|
end if
|
|
|
|
return
|
|
|
|
return
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
contains
|
|
|
|
|
|
|
|
subroutine mlprec_wrk_free(wrk)
|
|
|
|
|
|
|
|
type(psb_mlprec_wrk_type) :: wrk(:)
|
|
|
|
|
|
|
|
! This will not be needed when we have allocatables, as
|
|
|
|
|
|
|
|
! it is sufficient to deallocate the container, and
|
|
|
|
|
|
|
|
! the compiler is supposed to recursively deallocate the
|
|
|
|
|
|
|
|
! various components.
|
|
|
|
|
|
|
|
integer i
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
do i=1, size(wrk)
|
|
|
|
|
|
|
|
if (associated(wrk(i)%tx)) deallocate(wrk(i)%tx)
|
|
|
|
|
|
|
|
if (associated(wrk(i)%ty)) deallocate(wrk(i)%ty)
|
|
|
|
|
|
|
|
if (associated(wrk(i)%x2l)) deallocate(wrk(i)%x2l)
|
|
|
|
|
|
|
|
if (associated(wrk(i)%y2l)) deallocate(wrk(i)%y2l)
|
|
|
|
|
|
|
|
if (associated(wrk(i)%b2l)) deallocate(wrk(i)%b2l)
|
|
|
|
|
|
|
|
if (associated(wrk(i)%tty)) deallocate(wrk(i)%tty)
|
|
|
|
|
|
|
|
end do
|
|
|
|
|
|
|
|
end subroutine mlprec_wrk_free
|
|
|
|
|
|
|
|
|
|
|
|
end subroutine psb_dmlprc_aply
|
|
|
|
end subroutine psb_dmlprc_aply
|
|
|
|
|
|
|
|
|
|
|
|