Simplified algorithm of crystallite_integrateStress while preserving (almost) same functionality.
Removed "leapfrogging" (increase of step for next guess, when last guess was ok); Replaced Armijo rule testing for step size by simple check if the residuum got better, since the former virtually did not have any effect; consistently using the 2-norm of the residuum rather than infinity-norm for the convergence check throughout the function
This commit is contained in:
parent
1583ae74c3
commit
bb033c5fe7
|
@ -2731,8 +2731,7 @@ use debug, only: debug_level, &
|
|||
debug_g, &
|
||||
debug_cumLpCalls, &
|
||||
debug_cumLpTicks, &
|
||||
debug_StressLoopDistribution, &
|
||||
debug_LeapfrogBreakDistribution
|
||||
debug_StressLoopDistribution
|
||||
use constitutive, only: constitutive_LpAndItsTangent, &
|
||||
constitutive_TandItsTangent, &
|
||||
constitutive_homogenizedC
|
||||
|
@ -2779,7 +2778,6 @@ real(pReal), dimension(3,3):: Fg_new, &
|
|||
residuum, & ! current residuum of plastic velocity gradient
|
||||
residuum_old, & ! last residuum of plastic velocity gradient
|
||||
deltaLp, & ! direction of next guess
|
||||
gradientR, & ! derivative of the residuum norm
|
||||
Tstar,& ! 2nd Piola-Kirchhoff Stress
|
||||
A,&
|
||||
B, &
|
||||
|
@ -2796,10 +2794,8 @@ real(pReal), dimension(3,3,3,3):: dT_dFe3333, &
|
|||
dFe_dLp3333 ! partial derivative of elastic deformation gradient
|
||||
real(pReal) p_hydro, & ! volumetric part of 2nd Piola-Kirchhoff Stress
|
||||
det, & ! determinant
|
||||
expectedImprovement, &
|
||||
steplength0, &
|
||||
steplength, &
|
||||
steplength_max, &
|
||||
dt, & ! time increment
|
||||
aTol
|
||||
logical error ! flag indicating an error
|
||||
|
@ -2854,14 +2850,11 @@ invFp_current = math_inv33(Fp_current)
|
|||
if (all(invFp_current == 0.0_pReal)) then ! ... failed?
|
||||
#ifndef _OPENMP
|
||||
if (iand(debug_level(debug_crystallite), debug_levelBasic) /= 0_pInt) then
|
||||
write(6,'(a,i8,1x,i2,1x,i3)') '<< CRYST >> integrateStress failed on invFp_current inversion at el ip g ',e,i,g
|
||||
! QUESTION: all FP_current == 0.0, why reporting FP_new ??
|
||||
! if (iand(debug_level(debug_crystallite), debug_levelSelective) > 0_pInt &
|
||||
! .and. ((e == debug_e .and. i == debug_i .and. g == debug_g) &
|
||||
! .or. .not. iand(debug_level(debug_crystallite), debug_levelSelective) /= 0_pInt)) then
|
||||
! write(6,*)
|
||||
! write(6,'(a,/,3(12x,3(f12.7,1x)/))') '<< CRYST >> invFp_new',math_transpose33(invFp_new(1:3,1:3))
|
||||
! endif
|
||||
write(6,'(a,i8,1x,i2,1x,i3)') '<< CRYST >> integrateStress failed on inversion of Fp_current at el ip g ',e,i,g
|
||||
if (iand(debug_level(debug_crystallite), debug_levelExtensive) > 0_pInt) then
|
||||
write(6,*)
|
||||
write(6,'(a,/,3(12x,3(f12.7,1x)/))') '<< CRYST >> Fp_current',math_transpose33(Fp_current(1:3,1:3))
|
||||
endif
|
||||
endif
|
||||
#endif
|
||||
return
|
||||
|
@ -2874,8 +2867,8 @@ A = math_mul33x33(Fg_new,invFp_current) ! int
|
|||
NiterationStress = 0_pInt
|
||||
jacoCounter = 0_pInt
|
||||
steplength0 = 1.0_pReal
|
||||
steplength_max = 16.0_pReal
|
||||
steplength = steplength0
|
||||
residuum_old = huge(1.0_pReal)
|
||||
|
||||
LpLoop: do
|
||||
NiterationStress = NiterationStress + 1_pInt
|
||||
|
@ -2935,15 +2928,11 @@ LpLoop: do
|
|||
|
||||
!* update current residuum and check for convergence of loop
|
||||
|
||||
residuum = Lpguess - Lp_constitutive
|
||||
aTol = max(rTol_crystalliteStress * maxval(max(abs(Lpguess),abs(Lp_constitutive))), & ! absolute tolerance from largest acceptable relative error
|
||||
aTol = max(rTol_crystalliteStress * max(math_norm33(Lpguess),math_norm33(Lp_constitutive)), & ! absolute tolerance from largest acceptable relative error
|
||||
aTol_crystalliteStress) ! minimum lower cutoff
|
||||
if (.not. any(residuum /= residuum) & ! no convergence if NaN in residuum
|
||||
.and. maxval(abs(residuum)) < aTol ) exit LpLoop ! converged if all below absolute tolerance...
|
||||
residuum = Lpguess - Lp_constitutive
|
||||
|
||||
|
||||
!* NaN occurred at regular speed -> return
|
||||
if (steplength <= steplength0 .and. any(residuum /= residuum)) then
|
||||
if (any(residuum /= residuum)) then ! NaN in residuum...
|
||||
#ifndef _OPENMP
|
||||
if (iand(debug_level(debug_crystallite), debug_levelBasic) /= 0_pInt) then
|
||||
write(6,'(a,i8,1x,i2,1x,i3,a,i3,a)') '<< CRYST >> integrateStress encountered NaN at el ip g ',e,i,g,&
|
||||
|
@ -2951,68 +2940,21 @@ LpLoop: do
|
|||
' >> returning..!'
|
||||
endif
|
||||
#endif
|
||||
return ! me = .false. to inform integrator about problem
|
||||
endif
|
||||
|
||||
|
||||
if (NiterationStress > 1_pInt) then
|
||||
|
||||
!* not at regular speed
|
||||
if (steplength <= steplength0) then
|
||||
|
||||
!* Armijo rule is fullfilled (norm of residuum was reduced by at least 0.01 of what was expected)
|
||||
if (math_norm33(residuum) <= math_norm33(residuum_old) + 0.01_pReal * steplength * expectedImprovement) then
|
||||
|
||||
if (steplength < steplength0) then
|
||||
steplength = steplength0 ! return to normal step length
|
||||
elseif (sum(residuum * residuum_old) >= 0.0_pReal) then
|
||||
steplength = min(steplength_max,steplength + 1.0_pReal) ! no change in sign of residuum -> accelerate up to maximum speed
|
||||
endif
|
||||
!* Armijo rule not fullfilled -> try smaller step size in same direction
|
||||
else
|
||||
steplength = 0.5_pReal * steplength
|
||||
return ! ...me = .false. to inform integrator about problem
|
||||
elseif (math_norm33(residuum) < aTol) then ! converged if below absolute tolerance
|
||||
exit LpLoop ! ...leave iteration loop
|
||||
elseif (math_norm33(residuum) > math_norm33(residuum_old)) then ! not converged and worse residuum...
|
||||
steplength = 0.5_pReal * steplength ! ...try with smaller step length in same direction
|
||||
Lpguess = Lpguess_old + steplength * deltaLp
|
||||
cycle LpLoop
|
||||
endif
|
||||
|
||||
!* at high-speed
|
||||
else
|
||||
|
||||
!* no NaN, Armijo rule fullfilled, and sign of residuum did not change -> accelerate if not yet at maximum speed
|
||||
if (.not. any(residuum /= residuum) &
|
||||
.and. math_norm33(residuum) <= math_norm33(residuum_old) + 0.01_pReal * steplength * expectedImprovement &
|
||||
.and. sum(residuum * residuum_old) >= 0.0_pReal) then
|
||||
steplength = min(steplength_max,steplength + 1.0_pReal) ! accelerate up to maximum speed
|
||||
|
||||
!* something went wrong at accelerated speed? -> return to regular speed and try again
|
||||
else
|
||||
#ifndef _OPENMP
|
||||
if (iand(debug_level(debug_crystallite), debug_levelExtensive) /= 0_pInt) then
|
||||
write(6,'(a,i8,1x,i2,1x,i3,1x,a,i3)') '<< CRYST >> integrateStress encountered high-speed crash at el ip g ',e,i,g,&
|
||||
'; iteration ', NiterationStress
|
||||
endif
|
||||
#endif
|
||||
if (iand(debug_level(debug_crystallite), debug_levelBasic) /= 0_pInt) then
|
||||
!$OMP CRITICAL (distributionLeapfrogBreak)
|
||||
debug_LeapfrogBreakDistribution(NiterationStress,numerics_integrationMode) = &
|
||||
debug_LeapfrogBreakDistribution(NiterationStress,numerics_integrationMode) + 1_pInt
|
||||
!$OMP END CRITICAL (distributionLeapfrogBreak)
|
||||
endif
|
||||
|
||||
!* NaN occured -> use old guess and residuum
|
||||
if (any(residuum /= residuum)) then
|
||||
Lpguess = Lpguess_old
|
||||
residuum = residuum_old
|
||||
endif
|
||||
steplength_max = max(steplength - 1.0_pReal, 1.0_pReal) ! limit acceleration
|
||||
steplength = steplength0 ! grinding halt
|
||||
jacoCounter = 0_pInt ! reset counter for Jacobian update (we want to do an update next time!)
|
||||
endif
|
||||
endif
|
||||
else ! not converged, but improved norm of residuum...
|
||||
residuum_old = residuum ! ...remember old values and...
|
||||
Lpguess_old = Lpguess
|
||||
steplength = steplength0 ! ...proceed with normal step length (calculate new search direction)
|
||||
endif
|
||||
|
||||
|
||||
!* calculate Jacobian for correction term and remember current residuum and Lpguess
|
||||
!* calculate Jacobian for correction term
|
||||
|
||||
if (mod(jacoCounter, iJacoLpresiduum) == 0_pInt) then
|
||||
dFe_dLp3333 = 0.0_pReal
|
||||
|
@ -3052,19 +2994,10 @@ LpLoop: do
|
|||
#endif
|
||||
return
|
||||
endif
|
||||
|
||||
deltaLp = - math_plain9to33(work)
|
||||
gradientR = 0.0_pReal
|
||||
do k=1_pInt,3_pInt; do l=1_pInt,3_pInt; do m=1_pInt,3_pInt; do n=1_pInt,3_pInt
|
||||
gradientR(k,l) = gradientR(k,l) + dR_dLp(3*(k-1)+l,3_pInt*(m-1_pInt)+n) * residuum(m,n)
|
||||
enddo; enddo; enddo; enddo
|
||||
gradientR = gradientR / math_norm33(gradientR)
|
||||
expectedImprovement = math_mul33xx33(deltaLp, gradientR)
|
||||
endif
|
||||
|
||||
jacoCounter = jacoCounter + 1_pInt ! increase counter for jaco update
|
||||
residuum_old = residuum
|
||||
Lpguess_old = Lpguess
|
||||
|
||||
Lpguess = Lpguess + steplength * deltaLp
|
||||
|
||||
enddo LpLoop
|
||||
|
|
|
@ -92,7 +92,6 @@ module debug
|
|||
|
||||
integer(pInt), dimension(:,:), allocatable, public :: &
|
||||
debug_StressLoopDistribution, & ! distribution of stress iterations until convergence
|
||||
debug_LeapfrogBreakDistribution, & ! distribution of iterations where leapfrog breaks occurred
|
||||
debug_StateLoopDistribution ! distribution of state iterations until convergence
|
||||
|
||||
real(pReal), public :: &
|
||||
|
@ -151,10 +150,6 @@ subroutine debug_init
|
|||
deallocate(debug_StressLoopDistribution)
|
||||
allocate(debug_StressLoopDistribution(nStress+1,2))
|
||||
debug_StressLoopDistribution = 0_pInt
|
||||
if (allocated(debug_LeapfrogBreakDistribution)) &
|
||||
deallocate(debug_LeapfrogBreakDistribution)
|
||||
allocate(debug_LeapfrogBreakDistribution(nStress+1,2))
|
||||
debug_LeapfrogBreakDistribution = 0_pInt
|
||||
if (allocated(debug_StateLoopDistribution)) &
|
||||
deallocate(debug_StateLoopDistribution)
|
||||
allocate(debug_StateLoopDistribution(nState+1,2))
|
||||
|
@ -326,7 +321,6 @@ subroutine debug_reset
|
|||
implicit none
|
||||
|
||||
debug_StressLoopDistribution = 0_pInt ! initialize debugging data
|
||||
debug_LeapfrogBreakDistribution = 0_pInt
|
||||
debug_StateLoopDistribution = 0_pInt
|
||||
debug_CrystalliteLoopDistribution = 0_pInt
|
||||
debug_MaterialpointStateLoopDistribution = 0_pInt
|
||||
|
@ -411,20 +405,17 @@ subroutine debug_info
|
|||
integral = 0_pInt
|
||||
write(6,*)
|
||||
write(6,*)
|
||||
write(6,*) 'distribution_StressLoop : stress frogbreak stiffness frogbreak'
|
||||
write(6,*) 'distribution_StressLoop : stress stiffness'
|
||||
do i=1_pInt,nStress+1_pInt
|
||||
if (any(debug_StressLoopDistribution(i,:) /= 0_pInt ) .or. &
|
||||
any(debug_LeapfrogBreakDistribution(i,:) /= 0_pInt ) ) then
|
||||
if (any(debug_StressLoopDistribution(i,:) /= 0_pInt )) then
|
||||
integral = integral + i*(debug_StressLoopDistribution(i,1) + debug_StressLoopDistribution(i,2))
|
||||
exceed = ' '
|
||||
if (i > nStress) exceed = '+' ! last entry gets "+"
|
||||
write(6,'(i25,a1,i10,1x,i10,1x,i10,1x,i10)') min(nStress,i),exceed, &
|
||||
debug_StressLoopDistribution(i,1),debug_LeapfrogBreakDistribution(i,1), &
|
||||
debug_StressLoopDistribution(i,2),debug_LeapfrogBreakDistribution(i,2)
|
||||
write(6,'(i25,a1,i10,1x,i10)') min(nStress,i),exceed,debug_StressLoopDistribution(i,1),&
|
||||
debug_StressLoopDistribution(i,2)
|
||||
endif
|
||||
enddo
|
||||
write(6,'(a15,i10,1x,i10,12x,i10)') ' total',integral,&
|
||||
sum(debug_StressLoopDistribution(:,1)), &
|
||||
write(6,'(a15,i10,2(1x,i10))') ' total',integral,sum(debug_StressLoopDistribution(:,1)), &
|
||||
sum(debug_StressLoopDistribution(:,2))
|
||||
|
||||
integral = 0_pInt
|
||||
|
@ -435,12 +426,11 @@ subroutine debug_info
|
|||
integral = integral + i*(debug_StateLoopDistribution(i,1) + debug_StateLoopDistribution(i,2))
|
||||
exceed = ' '
|
||||
if (i > nState) exceed = '+' ! last entry gets "+"
|
||||
write(6,'(i25,a1,i10,12x,i10)') min(nState,i),exceed, &
|
||||
debug_StateLoopDistribution(i,1),debug_StateLoopDistribution(i,2)
|
||||
write(6,'(i25,a1,i10,1x,i10)') min(nState,i),exceed,debug_StateLoopDistribution(i,1),&
|
||||
debug_StateLoopDistribution(i,2)
|
||||
endif
|
||||
enddo
|
||||
write(6,'(a15,i10,1x,i10,12x,i10)') ' total',integral,&
|
||||
sum(debug_StateLoopDistribution(:,1)), &
|
||||
write(6,'(a15,i10,2(1x,i10))') ' total',integral,sum(debug_StateLoopDistribution(:,1)), &
|
||||
sum(debug_StateLoopDistribution(:,2))
|
||||
|
||||
integral = 0_pInt
|
||||
|
|
Loading…
Reference in New Issue