removed unused variables
This commit is contained in:
parent
b4678112cd
commit
7d84a0911e
|
@ -75,7 +75,6 @@ recursive function IO_abaqus_assembleInputFile(unit1,unit2) result(createSuccess
|
|||
character(len=300) line,fname
|
||||
integer(pInt), intent(in) :: unit1, unit2
|
||||
logical createSuccess,fexist
|
||||
integer(pInt) i
|
||||
|
||||
do
|
||||
read(unit2,'(A300)',END=220) line
|
||||
|
|
|
@ -91,7 +91,7 @@ subroutine constitutive_j2_init(file)
|
|||
integer(pInt), intent(in) :: file
|
||||
integer(pInt), parameter :: maxNchunks = 7
|
||||
integer(pInt), dimension(1+2*maxNchunks) :: positions
|
||||
integer(pInt) section, maxNinstance, i,j,k,l, output, mySize
|
||||
integer(pInt) section, maxNinstance, i,j,k, output, mySize
|
||||
character(len=64) tag
|
||||
character(len=1024) line
|
||||
|
||||
|
|
|
@ -703,9 +703,7 @@ real(pReal), dimension(constitutive_nonlocal_totalNslip(myInstance)) :: &
|
|||
rhoSglScrewPosUsed, & ! used positive screw dislocation density
|
||||
rhoSglScrewNegUsed, & ! used negative screw dislocation density
|
||||
rhoDipEdge, & ! edge dipole dislocation density
|
||||
rhoDipScrew, & ! screw dipole dislocation density
|
||||
rhoForest, & ! forest dislocation density
|
||||
tauSlipThreshold ! threshold shear stress for slip
|
||||
rhoDipScrew ! screw dipole dislocation density
|
||||
integer(pInt) ns, & ! short notation for total number of active slip systems
|
||||
f, & ! index of lattice family
|
||||
from, &
|
||||
|
@ -918,8 +916,7 @@ real(pReal), dimension(constitutive_nonlocal_totalNslip(phase_constitutionInstan
|
|||
rhoDip ! dipole dislocation density (edge, screw)
|
||||
real(pReal), dimension(constitutive_nonlocal_totalNslip(phase_constitutionInstance(material_phase(g,ip,el)))) :: &
|
||||
rhoForest, & ! forest dislocation density
|
||||
tauThreshold, & ! threshold shear stress
|
||||
tau ! resolved shear stress
|
||||
tauThreshold ! threshold shear stress
|
||||
|
||||
phase = material_phase(g,ip,el)
|
||||
instance = phase_constitutionInstance(phase)
|
||||
|
@ -1200,7 +1197,6 @@ real(pReal), dimension(constitutive_nonlocal_totalNslip(phase_constitutionInstan
|
|||
integer(pInt) myInstance, & ! current instance of this constitution
|
||||
myStructure, & ! current lattice structure
|
||||
ns, & ! short notation for the total number of active slip systems
|
||||
t, & ! dislocation type
|
||||
s ! index of my current slip system
|
||||
real(pReal), dimension(6) :: Tdislocation_v ! dislocation stress (resulting from the neighboring excess dislocation densities) as 2nd Piola-Kirchhoff stress
|
||||
real(pReal), dimension(constitutive_nonlocal_totalNslip(phase_constitutionInstance(material_phase(g,ip,el)))) :: &
|
||||
|
@ -1500,14 +1496,12 @@ integer(pInt) myInstance, & ! current
|
|||
t, & ! type of dislocation
|
||||
topp, & ! type of dislocation with opposite sign to t
|
||||
s, & ! index of my current slip system
|
||||
sLattice, & ! index of my current slip system according to lattice order
|
||||
i
|
||||
sLattice ! index of my current slip system according to lattice order
|
||||
real(pReal), dimension(constitutive_nonlocal_totalNslip(phase_constitutionInstance(material_phase(g,ip,el))),10) :: &
|
||||
rhoDot, & ! density evolution
|
||||
rhoDotRemobilization, & ! density evolution by remobilization
|
||||
rhoDotMultiplication, & ! density evolution by multiplication
|
||||
rhoDotFlux, & ! density evolution by flux
|
||||
neighboring_rhoDotFlux, & ! density evolution by flux at neighbor
|
||||
rhoDotSingle2DipoleGlide, & ! density evolution by dipole formation (by glide)
|
||||
rhoDotAthermalAnnihilation, & ! density evolution by athermal annihilation
|
||||
rhoDotThermalAnnihilation ! density evolution by thermal annihilation
|
||||
|
@ -1521,7 +1515,6 @@ real(pReal), dimension(constitutive_nonlocal_totalNslip(phase_constitutionInstan
|
|||
rhoForest, & ! forest dislocation density
|
||||
tauThreshold, & ! threshold shear stress
|
||||
tau, & ! current resolved shear stress
|
||||
invLambda, & ! inverse of mean free path for dislocations
|
||||
vClimb ! climb velocity of edge dipoles
|
||||
real(pReal), dimension(constitutive_nonlocal_totalNslip(phase_constitutionInstance(material_phase(g,ip,el))),2) :: &
|
||||
rhoDip, & ! current dipole dislocation densities (screw and edge dipoles)
|
||||
|
@ -1542,8 +1535,7 @@ real(pReal), dimension(3) :: normal_neighbor2me, & ! inte
|
|||
real(pReal) area, & ! area of the current interface
|
||||
transmissivity, & ! overall transmissivity of dislocation flux to neighboring material point
|
||||
lineLength, & ! dislocation line length leaving the current interface
|
||||
D, & ! self diffusion
|
||||
correction
|
||||
D ! self diffusion
|
||||
logical considerEnteringFlux, &
|
||||
considerLeavingFlux
|
||||
|
||||
|
|
|
@ -165,9 +165,9 @@ subroutine constitutive_phenopowerlaw_init(file)
|
|||
integer(pInt), intent(in) :: file
|
||||
integer(pInt), parameter :: maxNchunks = 21
|
||||
integer(pInt), dimension(1+2*maxNchunks) :: positions
|
||||
integer(pInt) section, maxNinstance, i,j,k,l,m, f,o, output, &
|
||||
integer(pInt) section, maxNinstance, i,j,k, f,o, output, &
|
||||
mySize, myStructure, index_myFamily, index_otherFamily
|
||||
character(len=64) tag,formatting
|
||||
character(len=64) tag
|
||||
character(len=1024) line
|
||||
|
||||
!$OMP CRITICAL (write2out)
|
||||
|
@ -753,7 +753,7 @@ function constitutive_phenopowerlaw_dotState(Tstar_v,Temperature,state,ipc,ip,el
|
|||
|
||||
!* Definition of variables
|
||||
integer(pInt) ipc,ip,el
|
||||
integer(pInt) matID,nSlip,nTwin,f,i,j,k, structID,index_Gamma,index_F,index_myFamily
|
||||
integer(pInt) matID,nSlip,nTwin,f,i,j, structID,index_Gamma,index_F,index_myFamily
|
||||
real(pReal) Temperature,c_slipslip,c_sliptwin,c_twinslip,c_twintwin, ssat_offset
|
||||
type(p_vec), dimension(homogenization_maxNgrains,mesh_maxNips,mesh_NcpElems) :: state
|
||||
real(pReal), dimension(6) :: Tstar_v
|
||||
|
|
|
@ -1168,7 +1168,7 @@ type(p_vec), dimension(homogenization_maxNgrains,mesh_maxNips,mesh_NcpElems), in
|
|||
integer(pInt) myInstance,myStructure,ns,nt,s,t,i
|
||||
real(pReal) sumf,sfe
|
||||
real(pReal), dimension(constitutive_titanmod_totalNtwin(phase_constitutionInstance(material_phase(g,ip,el)))) :: &
|
||||
fOverStacksize, volumefraction_pertwinsystem
|
||||
volumefraction_pertwinsystem
|
||||
|
||||
!* Shortened notation
|
||||
myInstance = phase_constitutionInstance(material_phase(g,ip,el))
|
||||
|
@ -1292,14 +1292,14 @@ real(pReal), dimension(9,9), intent(out) :: dLp_dTstar
|
|||
!* Local variables
|
||||
integer(pInt) myInstance,myStructure,ns,nt,f,i,j,k,l,m,n,index_myFamily
|
||||
real(pReal) sumf,StressRatio_edge_p,minusStressRatio_edge_p,StressRatio_edge_pminus1,StressRatio_screw_p, &
|
||||
StressRatio_screw_pminus1, StressRatio_r,BoltzmannRatioedge,DotGamma0, minusStressRatio_screw_p,gdotTotal, &
|
||||
StressRatio_screw_pminus1, BoltzmannRatioedge, minusStressRatio_screw_p, &
|
||||
screwvelocity_prefactor,twinStressRatio_p,twinminusStressRatio_p,twinStressRatio_pminus1, &
|
||||
twinStressRatio_r, twinDotGamma0,BoltzmannRatioscrew,BoltzmannRatiotwin,bottomstress_edge,bottomstress_screw
|
||||
twinDotGamma0,BoltzmannRatioscrew,BoltzmannRatiotwin,bottomstress_edge,bottomstress_screw
|
||||
real(pReal), dimension(3,3,3,3) :: dLp_dTstar3333
|
||||
real(pReal), dimension(constitutive_titanmod_totalNslip(phase_constitutionInstance(material_phase(g,ip,el)))) :: &
|
||||
gdot_slip,dgdot_dtauslip,tau_slip, edge_velocity, screw_velocity,gdot_slip_edge,gdot_slip_screw
|
||||
real(pReal), dimension(constitutive_titanmod_totalNtwin(phase_constitutionInstance(material_phase(g,ip,el)))) :: &
|
||||
gdot_twin,dgdot_dtautwin,tau_twin, twinedge_velocity, twinscrew_velocity,volumefraction_pertwinsystem
|
||||
gdot_twin,dgdot_dtautwin,tau_twin, volumefraction_pertwinsystem
|
||||
|
||||
!* Shortened notation
|
||||
myInstance = phase_constitutionInstance(material_phase(g,ip,el))
|
||||
|
@ -1597,17 +1597,15 @@ type(p_vec), dimension(homogenization_maxNgrains,mesh_maxNips,mesh_NcpElems), in
|
|||
real(pReal), dimension(constitutive_titanmod_sizeDotState(phase_constitutionInstance(material_phase(g,ip,el)))) :: &
|
||||
constitutive_titanmod_dotState
|
||||
!* Local variables
|
||||
integer(pInt) MyInstance,MyStructure,ns,nt,f,i,j,k,index_myFamily,s,t
|
||||
real(pReal) sumf,StressRatio_edge_p,minusStressRatio_edge_p,StressRatio_pminus1,BoltzmannRatio,DotGamma0,&
|
||||
EdgeDipMinDistance,AtomicVolume,VacancyDiffusion,StressRatio_r,StressRatio_screw_p,minusStressRatio_screw_p, &
|
||||
twinStressRatio_p,twinminusStressRatio_p,twinStressRatio_pminus1, &
|
||||
twinDotGamma0
|
||||
integer(pInt) MyInstance,MyStructure,ns,nt,f,i,j,index_myFamily
|
||||
real(pReal) sumf,BoltzmannRatio,&
|
||||
twinStressRatio_p,twinminusStressRatio_p
|
||||
real(pReal), dimension(constitutive_titanmod_totalNslip(phase_constitutionInstance(material_phase(g,ip,el)))) :: &
|
||||
gdot_slip,tau_slip,DotRhoEdgeGeneration,EdgeDipDistance,DotRhoEdgeAnnihilation,DotRhoScrewAnnihilation,&
|
||||
ClimbVelocity,DotRhoScrewGeneration, edge_velocity,screw_velocity
|
||||
DotRhoEdgeGeneration,DotRhoEdgeAnnihilation,DotRhoScrewAnnihilation,&
|
||||
DotRhoScrewGeneration
|
||||
real(pReal), dimension(constitutive_titanmod_totalNtwin(phase_constitutionInstance(material_phase(g,ip,el)))) :: gdot_twin, &
|
||||
tau_twin,twinedge_segment,twinscrew_segment,twinedge_velocity,twinscrew_velocity,TwinDotRhoEdgeGeneration, &
|
||||
TwinDotRhoEdgeAnnihilation,TwinDotRhoScrewGeneration,TwinDotRhoScrewAnnihilation,volumefraction_pertwinsystem
|
||||
tau_twin, &
|
||||
volumefraction_pertwinsystem
|
||||
|
||||
!* Shortened notation
|
||||
myInstance = phase_constitutionInstance(material_phase(g,ip,el))
|
||||
|
@ -1773,7 +1771,7 @@ integer(pInt), intent(in) :: g,ip,el
|
|||
real(pReal), intent(in) :: dt,Temperature
|
||||
real(pReal), dimension(6), intent(in) :: Tstar_v
|
||||
type(p_vec), dimension(homogenization_maxNgrains,mesh_maxNips,mesh_NcpElems), intent(in) :: state
|
||||
integer(pInt) myInstance,myStructure,ns,nt,f,o,i,c,j,index_myFamily
|
||||
integer(pInt) myInstance,myStructure,ns,nt,o,i,c
|
||||
real(pReal) sumf
|
||||
real(pReal), dimension(constitutive_titanmod_sizePostResults(phase_constitutionInstance(material_phase(g,ip,el)))) :: &
|
||||
constitutive_titanmod_postResults
|
||||
|
|
|
@ -157,18 +157,14 @@ integer(pInt) g, & ! grain number
|
|||
eMax, & ! maximum number of elements
|
||||
nMax, & ! maximum number of ip neighbors
|
||||
myNgrains, & ! number of grains in current IP
|
||||
myCrystallite, & ! crystallite of current elem
|
||||
section, &
|
||||
f, &
|
||||
j, &
|
||||
k, &
|
||||
p, &
|
||||
output, &
|
||||
mySize, &
|
||||
myStructure, & ! lattice structure
|
||||
myPhase, &
|
||||
myMat, &
|
||||
index_myFamily
|
||||
myMat
|
||||
character(len=64) tag
|
||||
character(len=1024) line
|
||||
|
||||
|
@ -492,13 +488,11 @@ logical, intent(in) :: updateJaco
|
|||
!*** output variables ***!
|
||||
|
||||
!*** local variables ***!
|
||||
real(pReal) myTemperature, & ! local copy of the temperature
|
||||
myPert, & ! perturbation with correct sign
|
||||
real(pReal) myPert, & ! perturbation with correct sign
|
||||
formerSubStep
|
||||
real(pReal), dimension(3,3) :: invFp, & ! inverse of the plastic deformation gradient
|
||||
Fe_guess, & ! guess for elastic deformation gradient
|
||||
Tstar ! 2nd Piola-Kirchhoff stress tensor
|
||||
real(pReal), dimension(9,9) :: dPdF99
|
||||
real(pReal), dimension(3,3,3,3,homogenization_maxNgrains,mesh_maxNips,mesh_NcpElems) :: &
|
||||
dPdF_perturbation1, &
|
||||
dPdF_perturbation2
|
||||
|
@ -1156,7 +1150,6 @@ integer(pInt), optional, intent(in):: ee, & ! elemen
|
|||
integer(pInt) e, & ! element index in element loop
|
||||
i, & ! integration point index in ip loop
|
||||
g, & ! grain index in grain loop
|
||||
j, &
|
||||
n, & ! stage index in integration stage loop
|
||||
mySizeDotState, & ! size of dot State
|
||||
s ! state index
|
||||
|
@ -1635,8 +1628,6 @@ integer(pInt), optional, intent(in):: ee, & ! elemen
|
|||
integer(pInt) e, & ! element index in element loop
|
||||
i, & ! integration point index in ip loop
|
||||
g, & ! grain index in grain loop
|
||||
j, &
|
||||
n, & ! stage index in integration stage loop
|
||||
mySizeDotState, & ! size of dot State
|
||||
s ! state index
|
||||
integer(pInt), dimension(2) :: eIter ! bounds for element iteration
|
||||
|
@ -1913,7 +1904,6 @@ integer(pInt), optional, intent(in):: ee, & ! elemen
|
|||
integer(pInt) e, & ! element index in element loop
|
||||
i, & ! integration point index in ip loop
|
||||
g, & ! grain index in grain loop
|
||||
n, &
|
||||
mySizeDotState
|
||||
integer(pInt), dimension(2) :: eIter ! bounds for element iteration
|
||||
integer(pInt), dimension(2,mesh_NcpElems) :: iIter, & ! bounds for ip iteration
|
||||
|
@ -3051,8 +3041,7 @@ function crystallite_postResults(&
|
|||
|
||||
!*** local variables ***!
|
||||
real(pReal), dimension(3,3) :: Ee
|
||||
integer(pInt) k,l,o,c,crystID,mySize
|
||||
logical error
|
||||
integer(pInt) o,c,crystID,mySize
|
||||
|
||||
crystID = microstructure_crystallite(mesh_element(4,e))
|
||||
|
||||
|
|
|
@ -87,7 +87,7 @@ implicit none
|
|||
|
||||
real(pReal) Temperature
|
||||
integer(pInt), parameter :: fileunit = 200
|
||||
integer(pInt) e,i,g,p,myInstance,j
|
||||
integer(pInt) e,i,p,myInstance
|
||||
integer(pInt), dimension(:,:), pointer :: thisSize
|
||||
character(len=64), dimension(:,:), pointer :: thisOutput
|
||||
logical knownHomogenization
|
||||
|
@ -303,7 +303,6 @@ subroutine materialpoint_stressAndItsTangent(&
|
|||
logical, intent(in) :: updateJaco
|
||||
integer(pInt) NiterationHomog,NiterationMPstate
|
||||
integer(pInt) g,i,e,myNgrains
|
||||
logical error
|
||||
|
||||
! ------ initialize to starting condition ------
|
||||
|
||||
|
|
|
@ -74,7 +74,7 @@ subroutine homogenization_RGC_init(&
|
|||
integer(pInt), intent(in) :: file
|
||||
integer(pInt), parameter :: maxNchunks = 4
|
||||
integer(pInt), dimension(1+2*maxNchunks) :: positions
|
||||
integer(pInt) section, maxNinstance, i,j,k,l,e, output, mySize, myInstance
|
||||
integer(pInt) section, maxNinstance, i,j,e, output, mySize, myInstance
|
||||
character(len=64) tag
|
||||
character(len=1024) line
|
||||
|
||||
|
@ -364,11 +364,11 @@ function homogenization_RGC_updateState(&
|
|||
integer(pInt), dimension (4) :: intFaceN,intFaceP,faceID
|
||||
integer(pInt), dimension (3) :: nGDim,iGr3N,iGr3P,stresLoc
|
||||
integer(pInt), dimension (2) :: residLoc
|
||||
integer(pInt) homID,i1,i2,i3,iNum,i,j,nIntFaceTot,iGrN,iGrP,iMun,iFace,k,l,ival,ipert,iGrain,nGrain
|
||||
integer(pInt) homID,iNum,i,j,nIntFaceTot,iGrN,iGrP,iMun,iFace,k,l,ival,ipert,iGrain,nGrain
|
||||
real(pReal), dimension (3,3,homogenization_maxNgrains) :: R,pF,pR,D,pD
|
||||
real(pReal), dimension (3,homogenization_maxNgrains) :: NN,pNN
|
||||
real(pReal), dimension (3) :: normP,normN,mornP,mornN
|
||||
real(pReal) residMax,stresMax,constitutiveWork,penaltyEnergy,volDiscrep,penDiscrep
|
||||
real(pReal) residMax,stresMax,constitutiveWork,penaltyEnergy,volDiscrep
|
||||
logical error,RGCdebug,RGCdebugJacobi,RGCcheck
|
||||
!
|
||||
integer(pInt), parameter :: nFace = 6
|
||||
|
@ -804,7 +804,7 @@ subroutine homogenization_RGC_averageStressAndItsTangent(&
|
|||
real(pReal), dimension (9,9) :: dPdF99
|
||||
integer(pInt), intent(in) :: ip,el
|
||||
!
|
||||
logical homogenization_RGC_stateUpdate,RGCdebug
|
||||
logical RGCdebug
|
||||
integer(pInt) homID, i, j, Ngrains, iGrain
|
||||
|
||||
RGCdebug = .false. !(ip == 1 .and. el == 1)
|
||||
|
@ -853,7 +853,7 @@ function homogenization_RGC_averageTemperature(&
|
|||
real(pReal), dimension (homogenization_maxNgrains), intent(in) :: Temperature
|
||||
integer(pInt), intent(in) :: ip,el
|
||||
real(pReal) homogenization_RGC_averageTemperature
|
||||
integer(pInt) homID, i, Ngrains
|
||||
integer(pInt) homID, Ngrains
|
||||
|
||||
!* Computing the average temperature
|
||||
Ngrains = homogenization_Ngrains(mesh_element(3,el))
|
||||
|
@ -950,11 +950,11 @@ subroutine homogenization_RGC_stressPenalty(&
|
|||
integer(pInt), intent(in) :: ip,el
|
||||
integer(pInt), dimension (4) :: intFace
|
||||
integer(pInt), dimension (3) :: iGrain3,iGNghb3,nGDim
|
||||
real(pReal), dimension (3,3) :: gDef,nDef,avgC
|
||||
real(pReal), dimension (3,3) :: gDef,nDef
|
||||
real(pReal), dimension (3) :: nVect,surfCorr
|
||||
real(pReal), dimension (2) :: Gmoduli
|
||||
integer(pInt) homID,iGrain,iGNghb,iFace,i,j,k,l,m
|
||||
real(pReal) muGrain,muGNghb,nDefNorm,xiAlpha,ciAlpha,bgGrain,bgGNghb,detF
|
||||
integer(pInt) homID,iGrain,iGNghb,iFace,i,j,k,l
|
||||
real(pReal) muGrain,muGNghb,nDefNorm,bgGrain,bgGNghb
|
||||
!
|
||||
integer(pInt), parameter :: nFace = 6
|
||||
real(pReal), parameter :: nDefToler = 1.0e-10
|
||||
|
@ -1084,7 +1084,7 @@ subroutine homogenization_RGC_volumePenalty(&
|
|||
real(pReal), dimension (3,3), intent(in) :: fAvg
|
||||
integer(pInt), intent(in) :: ip,el
|
||||
real(pReal), dimension (homogenization_maxNgrains) :: gVol
|
||||
integer(pInt) homID,iGrain,nGrain,i,j
|
||||
integer(pInt) homID,iGrain,nGrain
|
||||
!
|
||||
nGrain = homogenization_Ngrains(mesh_element(3,el))
|
||||
|
||||
|
@ -1251,7 +1251,7 @@ function homogenization_RGC_interfaceNormal(&
|
|||
real(pReal), dimension (3) :: homogenization_RGC_interfaceNormal
|
||||
integer(pInt), dimension (4), intent(in) :: intFace
|
||||
integer(pInt), intent(in) :: ip,el
|
||||
integer(pInt) nPos,i
|
||||
integer(pInt) nPos
|
||||
|
||||
!* Get the normal of the interface, identified from the value of intFace(1)
|
||||
homogenization_RGC_interfaceNormal = 0.0_pReal
|
||||
|
@ -1371,7 +1371,7 @@ function homogenization_RGC_interface4to1(&
|
|||
integer(pInt), dimension (4), intent(in) :: iFace4D
|
||||
integer(pInt) :: homogenization_RGC_interface4to1
|
||||
integer(pInt), dimension (3) :: nGDim,nIntFace
|
||||
integer(pInt) homID,dir
|
||||
integer(pInt) homID
|
||||
|
||||
nGDim = homogenization_RGC_Ngrains(:,homID)
|
||||
!* Compute the total number of interfaces, which ...
|
||||
|
|
|
@ -69,7 +69,7 @@ subroutine homogenization_isostrain_init(&
|
|||
integer(pInt), intent(in) :: file
|
||||
integer(pInt), parameter :: maxNchunks = 2
|
||||
integer(pInt), dimension(1+2*maxNchunks) :: positions
|
||||
integer(pInt) section, maxNinstance, i,j,k,l, output, mySize
|
||||
integer(pInt) section, maxNinstance, i,j, output, mySize
|
||||
character(len=64) tag
|
||||
character(len=1024) line
|
||||
|
||||
|
@ -190,7 +190,7 @@ subroutine homogenization_isostrain_partitionDeformation(&
|
|||
real(pReal), dimension (3,3), intent(in) :: avgF
|
||||
type(p_vec), intent(in) :: state
|
||||
integer(pInt), intent(in) :: ip,el
|
||||
integer(pInt) homID, i
|
||||
integer(pInt) i
|
||||
|
||||
! homID = homogenization_typeInstance(mesh_element(3,el))
|
||||
forall (i = 1:homogenization_Ngrains(mesh_element(3,el))) &
|
||||
|
@ -259,8 +259,7 @@ subroutine homogenization_isostrain_averageStressAndItsTangent(&
|
|||
real(pReal), dimension (3,3,homogenization_maxNgrains), intent(in) :: P
|
||||
real(pReal), dimension (3,3,3,3,homogenization_maxNgrains), intent(in) :: dPdF
|
||||
integer(pInt), intent(in) :: ip,el
|
||||
logical homogenization_isostrain_stateUpdate
|
||||
integer(pInt) homID, i, Ngrains
|
||||
integer(pInt) Ngrains
|
||||
|
||||
! homID = homogenization_typeInstance(mesh_element(3,el))
|
||||
Ngrains = homogenization_Ngrains(mesh_element(3,el))
|
||||
|
@ -290,7 +289,7 @@ function homogenization_isostrain_averageTemperature(&
|
|||
real(pReal), dimension (homogenization_maxNgrains), intent(in) :: Temperature
|
||||
integer(pInt), intent(in) :: ip,el
|
||||
real(pReal) homogenization_isostrain_averageTemperature
|
||||
integer(pInt) homID, i, Ngrains
|
||||
integer(pInt) Ngrains
|
||||
|
||||
! homID = homogenization_typeInstance(mesh_element(3,el))
|
||||
Ngrains = homogenization_Ngrains(mesh_element(3,el))
|
||||
|
|
|
@ -712,7 +712,7 @@ subroutine lattice_init()
|
|||
implicit none
|
||||
|
||||
integer(pInt), parameter :: fileunit = 200
|
||||
integer(pInt) i,Nsections
|
||||
integer(pInt) Nsections
|
||||
|
||||
!$OMP CRITICAL (write2out)
|
||||
write(6,*)
|
||||
|
|
|
@ -341,7 +341,6 @@ subroutine material_parseCrystallite(file,myPart)
|
|||
character(len=*), intent(in) :: myPart
|
||||
integer(pInt), intent(in) :: file
|
||||
integer(pInt) Nsections, section
|
||||
character(len=64) tag
|
||||
character(len=1024) line
|
||||
|
||||
Nsections = IO_countSections(file,myPart)
|
||||
|
|
|
@ -146,7 +146,6 @@ real(pReal), dimension(4,36), parameter :: math_symOperations = &
|
|||
real(pReal), dimension(3,3) :: R,R2
|
||||
real(pReal), dimension(3) :: Eulers
|
||||
real(pReal), dimension(4) :: q,q2,axisangle
|
||||
real(pReal), dimension(2) :: rnd
|
||||
integer(pInt), dimension(1) :: randInit
|
||||
|
||||
|
||||
|
@ -487,7 +486,7 @@ real(pReal), dimension(4,36), parameter :: math_symOperations = &
|
|||
integer(pInt) i,j
|
||||
real(pReal), dimension(3,3,3,3), intent(in) :: A
|
||||
real(pReal), dimension(3,3), intent(in) :: B
|
||||
real(pReal), dimension(3,3) :: C,math_mul3333xx33
|
||||
real(pReal), dimension(3,3) :: math_mul3333xx33
|
||||
|
||||
do i = 1,3
|
||||
do j = 1,3
|
||||
|
@ -1598,7 +1597,6 @@ pure function math_transpose3x3(A)
|
|||
|
||||
real(pReal), dimension(4), intent(in) :: Q
|
||||
real(pReal), dimension(3,3) :: math_QuaternionToR, T,S
|
||||
real(pReal) w2
|
||||
integer(pInt) i, j
|
||||
|
||||
forall (i = 1:3, j = 1:3) &
|
||||
|
|
|
@ -1935,7 +1935,7 @@ endsubroutine
|
|||
character(len=300) line
|
||||
|
||||
integer(pInt) unit,i,count
|
||||
logical inPart,materialFound
|
||||
logical inPart
|
||||
character(len=64) elemSetName,materialName
|
||||
|
||||
allocate (mesh_nameMaterial(mesh_Nmaterials)) ; mesh_nameMaterial = ''
|
||||
|
@ -2962,7 +2962,7 @@ integer(pInt) myElem, & ! my CP element index
|
|||
dir, & ! direction of periodicity
|
||||
matchingElem, & ! CP elem number of matching element
|
||||
matchingFace, & ! face ID of matching element
|
||||
k, a, anchor
|
||||
a, anchor
|
||||
integer(pInt), dimension(FE_maxmaxNnodesAtIP) :: &
|
||||
linkedNodes, &
|
||||
matchingNodes
|
||||
|
|
Loading…
Reference in New Issue