less generic variables

This commit is contained in:
Sharan Roongta 2020-06-19 02:32:33 +02:00
parent d2791088f2
commit 7c4afe06c9
11 changed files with 60 additions and 84 deletions

@ -1 +1 @@
Subproject commit 6f818e871d6415fa4ebe2a5781920bad614d02e8 Subproject commit f391a36c2e829f2cb4db2297271941168f7fd7d8

View File

@ -92,8 +92,7 @@ program DAMASK_grid
external :: & external :: &
quit quit
class (tNode), pointer :: & class (tNode), pointer :: &
num_grid, & num_grid
num_generic
!-------------------------------------------------------------------------------------------------- !--------------------------------------------------------------------------------------------------
! init DAMASK (all modules) ! init DAMASK (all modules)
@ -114,9 +113,9 @@ program DAMASK_grid
!------------------------------------------------------------------------------------------------- !-------------------------------------------------------------------------------------------------
! reading field paramters from numerics file and do sanity checks ! reading field paramters from numerics file and do sanity checks
num_generic => numerics_root%get('generic', defaultVal=emptyDict) num_grid => numerics_root%get('grid', defaultVal=emptyDict)
stagItMax = num_generic%get_asInt('maxStaggeredIter',defaultVal=10) stagItMax = num_grid%get_asInt('maxStaggeredIter',defaultVal=10)
maxCutBack = num_generic%get_asInt('maxCutBack',defaultVal=3) maxCutBack = num_grid%get_asInt('maxCutBack',defaultVal=3)
if (stagItMax < 0) call IO_error(301,ext_msg='maxStaggeredIter') if (stagItMax < 0) call IO_error(301,ext_msg='maxStaggeredIter')
if (maxCutBack < 0) call IO_error(301,ext_msg='maxCutBack') if (maxCutBack < 0) call IO_error(301,ext_msg='maxCutBack')
@ -124,8 +123,6 @@ program DAMASK_grid
!-------------------------------------------------------------------------------------------------- !--------------------------------------------------------------------------------------------------
! assign mechanics solver depending on selected type ! assign mechanics solver depending on selected type
num_grid => numerics_root%get('grid',defaultVal=emptyDict)
select case (trim(num_grid%get_asString('solver', defaultVal = 'Basic'))) select case (trim(num_grid%get_asString('solver', defaultVal = 'Basic')))
case ('Basic') case ('Basic')
mech_init => grid_mech_spectral_basic_init mech_init => grid_mech_spectral_basic_init

View File

@ -61,7 +61,7 @@ subroutine grid_damage_spectral_init
Vec :: uBound, lBound Vec :: uBound, lBound
PetscErrorCode :: ierr PetscErrorCode :: ierr
class(tNode), pointer :: & class(tNode), pointer :: &
num_generic num_grid
character(len=pStringLen) :: & character(len=pStringLen) :: &
snes_type, & snes_type, &
petsc_options petsc_options
@ -73,8 +73,8 @@ subroutine grid_damage_spectral_init
!------------------------------------------------------------------------------------------------- !-------------------------------------------------------------------------------------------------
! read numerical parameter ! read numerical parameter
num_generic => numerics_root%get('generic',defaultVal=emptyDict) num_grid => numerics_root%get('grid',defaultVal=emptyDict)
petsc_options = num_generic%get_asString('petsc_options',defaultVal='') petsc_options = num_grid%get_asString('petsc_options',defaultVal='')
!-------------------------------------------------------------------------------------------------- !--------------------------------------------------------------------------------------------------
! set default and user defined options for PETSc ! set default and user defined options for PETSc
@ -150,7 +150,7 @@ function grid_damage_spectral_solution(timeinc,timeinc_old) result(solution)
itmax !< maximum number of iterations itmax !< maximum number of iterations
type(tSolutionState) :: solution type(tSolutionState) :: solution
class(tNode), pointer :: & class(tNode), pointer :: &
num_generic num_grid
PetscInt :: devNull PetscInt :: devNull
PetscReal :: phi_min, phi_max, stagNorm, solnNorm PetscReal :: phi_min, phi_max, stagNorm, solnNorm
@ -159,8 +159,8 @@ function grid_damage_spectral_solution(timeinc,timeinc_old) result(solution)
!------------------------------------------------------------------- !-------------------------------------------------------------------
! reading numerical parameter and do sanity check ! reading numerical parameter and do sanity check
num_generic => numerics_root%get('generic',defaultVal=emptyDict) num_grid => numerics_root%get('grid',defaultVal=emptyDict)
itmax = num_generic%get_asInt('itmax',defaultVal=250) itmax = num_grid%get_asInt('itmax',defaultVal=250)
if (itmax <= 1) call IO_error(301,ext_msg='itmax') if (itmax <= 1) call IO_error(301,ext_msg='itmax')
solution%converged =.false. solution%converged =.false.

View File

@ -100,7 +100,7 @@ subroutine grid_mech_FEM_init
fileName, & fileName, &
petsc_options petsc_options
class(tNode), pointer :: & class(tNode), pointer :: &
num_generic num_grid
real(pReal), dimension(3,3,3,3) :: devNull real(pReal), dimension(3,3,3,3) :: devNull
PetscScalar, pointer, dimension(:,:,:,:) :: & PetscScalar, pointer, dimension(:,:,:,:) :: &
u_current,u_lastInc u_current,u_lastInc
@ -109,8 +109,8 @@ subroutine grid_mech_FEM_init
!------------------------------------------------------------------------------------------------- !-------------------------------------------------------------------------------------------------
! read numerical parameter ! read numerical parameter
num_generic => numerics_root%get('generic',defaultVal=emptyDict) num_grid => numerics_root%get('grid',defaultVal=emptyDict)
petsc_options = num_generic%get_asString('petsc_options',defaultVal='') petsc_options = num_grid%get_asString('petsc_options',defaultVal='')
!-------------------------------------------------------------------------------------------------- !--------------------------------------------------------------------------------------------------
! set default and user defined options for PETSc ! set default and user defined options for PETSc
@ -431,8 +431,7 @@ subroutine converged(snes_local,PETScIter,devNull1,devNull2,fnorm,reason,dummy,i
eps_stress_atol, & !< absolute tolerance for fullfillment of stress BC eps_stress_atol, & !< absolute tolerance for fullfillment of stress BC
eps_stress_rtol !< relative tolerance for fullfillment of stress BC eps_stress_rtol !< relative tolerance for fullfillment of stress BC
class(tNode), pointer :: & class(tNode), pointer :: &
num_grid, & num_grid
num_generic
!----------------------------------------------------------------------------------- !-----------------------------------------------------------------------------------
! reading numerical parameters and do sanity check ! reading numerical parameters and do sanity check
@ -442,9 +441,8 @@ subroutine converged(snes_local,PETScIter,devNull1,devNull2,fnorm,reason,dummy,i
eps_stress_atol = num_grid%get_asFloat('eps_stress_atol',defaultVal=1.0e3_pReal) eps_stress_atol = num_grid%get_asFloat('eps_stress_atol',defaultVal=1.0e3_pReal)
eps_stress_rtol = num_grid%get_asFloat('eps_stress_rtol',defaultVal=0.01_pReal) eps_stress_rtol = num_grid%get_asFloat('eps_stress_rtol',defaultVal=0.01_pReal)
num_generic => numerics_root%get('generic',defaultVal=emptyDict) itmin = num_grid%get_asInt('itmin',defaultVal=1)
itmin = num_generic%get_asInt('itmin',defaultVal=1) itmax = num_grid%get_asInt('itmax',defaultVal=250)
itmax = num_generic%get_asInt('itmax',defaultVal=250)
if (eps_div_atol <= 0.0_pReal) call IO_error(301,ext_msg='eps_div_atol') if (eps_div_atol <= 0.0_pReal) call IO_error(301,ext_msg='eps_div_atol')
if (eps_div_rtol < 0.0_pReal) call IO_error(301,ext_msg='eps_div_rtol') if (eps_div_rtol < 0.0_pReal) call IO_error(301,ext_msg='eps_div_rtol')
@ -505,13 +503,13 @@ subroutine formResidual(da_local,x_local, &
itmin, & itmin, &
itmax itmax
class(tNode), pointer :: & class(tNode), pointer :: &
num_generic num_grid
!---------------------------------------------------------------------- !----------------------------------------------------------------------
! read numerical paramteters and do sanity checks ! read numerical paramteters and do sanity checks
num_generic => numerics_root%get('generic',defaultVal=emptyDict) num_grid => numerics_root%get('grid',defaultVal=emptyDict)
itmin = num_generic%get_asInt('itmin',defaultVal=1) itmin = num_grid%get_asInt('itmin',defaultVal=1)
itmax = num_generic%get_asInt('itmax',defaultVal=250) itmax = num_grid%get_asInt('itmax',defaultVal=250)
if (itmax <= 1) call IO_error(301,ext_msg='itmax') if (itmax <= 1) call IO_error(301,ext_msg='itmax')
if (itmin > itmax .or. itmin < 1) call IO_error(301,ext_msg='itmin') if (itmin > itmax .or. itmin < 1) call IO_error(301,ext_msg='itmin')

View File

@ -89,8 +89,7 @@ subroutine grid_mech_spectral_basic_init
real(pReal), dimension(3,3) :: & real(pReal), dimension(3,3) :: &
temp33_Real = 0.0_pReal temp33_Real = 0.0_pReal
class (tNode), pointer :: & class (tNode), pointer :: &
num_grid, & num_grid
num_generic
PetscErrorCode :: ierr PetscErrorCode :: ierr
PetscScalar, pointer, dimension(:,:,:,:) :: & PetscScalar, pointer, dimension(:,:,:,:) :: &
@ -112,10 +111,8 @@ subroutine grid_mech_spectral_basic_init
!------------------------------------------------------------------------------------------------- !-------------------------------------------------------------------------------------------------
! read numerical parameters ! read numerical parameters
num_generic => numerics_root%get('generic',defaultVal=emptyDict)
petsc_options = num_generic%get_asString('petsc_options',defaultVal='')
num_grid => numerics_root%get('grid',defaultVal=emptyDict) num_grid => numerics_root%get('grid',defaultVal=emptyDict)
petsc_options = num_grid%get_asString('petsc_options',defaultVal='')
num%update_gamma = num_grid%get_asBool('update_gamma',defaultVal=.false.) num%update_gamma = num_grid%get_asBool('update_gamma',defaultVal=.false.)
!-------------------------------------------------------------------------------------------------- !--------------------------------------------------------------------------------------------------
@ -403,8 +400,8 @@ subroutine converged(snes_local,PETScIter,devNull1,devNull2,devNull3,reason,dumm
eps_stress_atol, & !< absolute tolerance for fullfillment of stress BC eps_stress_atol, & !< absolute tolerance for fullfillment of stress BC
eps_stress_rtol !< relative tolerance for fullfillment of stress BC eps_stress_rtol !< relative tolerance for fullfillment of stress BC
class(tNode), pointer :: & class(tNode), pointer :: &
num_grid, & num_grid
num_generic
!----------------------------------------------------------------------------------- !-----------------------------------------------------------------------------------
! reading numerical parameters and do sanity check ! reading numerical parameters and do sanity check
num_grid => numerics_root%get('grid',defaultVal=emptyDict) num_grid => numerics_root%get('grid',defaultVal=emptyDict)
@ -413,9 +410,8 @@ subroutine converged(snes_local,PETScIter,devNull1,devNull2,devNull3,reason,dumm
eps_stress_atol = num_grid%get_asFloat('eps_stress_atol',defaultVal=1.0e3_pReal) eps_stress_atol = num_grid%get_asFloat('eps_stress_atol',defaultVal=1.0e3_pReal)
eps_stress_rtol = num_grid%get_asFloat('eps_stress_rtol',defaultVal=0.01_pReal) eps_stress_rtol = num_grid%get_asFloat('eps_stress_rtol',defaultVal=0.01_pReal)
num_generic => numerics_root%get('generic',defaultVal=emptyDict) itmin = num_grid%get_asInt('itmin',defaultVal=1)
itmin = num_generic%get_asInt('itmin',defaultVal=1) itmax = num_grid%get_asInt('itmax',defaultVal=250)
itmax = num_generic%get_asInt('itmax',defaultVal=250)
if (eps_div_atol <= 0.0_pReal) call IO_error(301,ext_msg='eps_div_atol') if (eps_div_atol <= 0.0_pReal) call IO_error(301,ext_msg='eps_div_atol')
if (eps_div_rtol < 0.0_pReal) call IO_error(301,ext_msg='eps_div_rtol') if (eps_div_rtol < 0.0_pReal) call IO_error(301,ext_msg='eps_div_rtol')
@ -474,13 +470,13 @@ subroutine formResidual(in, F, &
itmin, & itmin, &
itmax itmax
class(tNode), pointer :: & class(tNode), pointer :: &
num_generic num_grid
!---------------------------------------------------------------------- !----------------------------------------------------------------------
! read numerical paramteter and do sanity checks ! read numerical paramteter and do sanity checks
num_generic => numerics_root%get('generic',defaultVal=emptyDict) num_grid => numerics_root%get('grid',defaultVal=emptyDict)
itmin = num_generic%get_asInt('itmin',defaultVal=1) itmin = num_grid%get_asInt('itmin',defaultVal=1)
itmax = num_generic%get_asInt('itmax',defaultVal=250) itmax = num_grid%get_asInt('itmax',defaultVal=250)
if (itmax <= 1) call IO_error(301,ext_msg='itmax') if (itmax <= 1) call IO_error(301,ext_msg='itmax')
if (itmin > itmax .or. itmin < 1) call IO_error(301,ext_msg='itmin') if (itmin > itmax .or. itmin < 1) call IO_error(301,ext_msg='itmin')

View File

@ -96,8 +96,7 @@ subroutine grid_mech_spectral_polarisation_init
real(pReal), dimension(3,3) :: & real(pReal), dimension(3,3) :: &
temp33_Real = 0.0_pReal temp33_Real = 0.0_pReal
class (tNode), pointer :: & class (tNode), pointer :: &
num_grid, & num_grid
num_generic
PetscErrorCode :: ierr PetscErrorCode :: ierr
PetscScalar, pointer, dimension(:,:,:,:) :: & PetscScalar, pointer, dimension(:,:,:,:) :: &
@ -118,10 +117,8 @@ subroutine grid_mech_spectral_polarisation_init
!------------------------------------------------------------------------------------------------- !-------------------------------------------------------------------------------------------------
! read numerical parameters ! read numerical parameters
num_generic => numerics_root%get('generic',defaultVal=emptyDict)
petsc_options = num_generic%get_asString('petsc_options',defaultVal='')
num_grid => numerics_root%get('grid',defaultVal=emptyDict) num_grid => numerics_root%get('grid',defaultVal=emptyDict)
petsc_options = num_grid%get_asString('petsc_options',defaultVal='')
num%update_gamma = num_grid%get_asBool('update_gamma',defaultVal=.false.) num%update_gamma = num_grid%get_asBool('update_gamma',defaultVal=.false.)
!-------------------------------------------------------------------------------------------------- !--------------------------------------------------------------------------------------------------
@ -453,8 +450,7 @@ subroutine converged(snes_local,PETScIter,devNull1,devNull2,devNull3,reason,dumm
eps_stress_atol, & !< absolute tolerance for fullfillment of stress BC eps_stress_atol, & !< absolute tolerance for fullfillment of stress BC
eps_stress_rtol !< relative tolerance for fullfillment of stress BC eps_stress_rtol !< relative tolerance for fullfillment of stress BC
class(tNode), pointer :: & class(tNode), pointer :: &
num_grid, & num_grid
num_generic
!----------------------------------------------------------------------------------- !-----------------------------------------------------------------------------------
! reading numerical parameters and do sanity check ! reading numerical parameters and do sanity check
@ -466,9 +462,8 @@ subroutine converged(snes_local,PETScIter,devNull1,devNull2,devNull3,reason,dumm
eps_stress_atol = num_grid%get_asFloat('eps_stress_atol',defaultVal=1.0e3_pReal) eps_stress_atol = num_grid%get_asFloat('eps_stress_atol',defaultVal=1.0e3_pReal)
eps_stress_rtol = num_grid%get_asFloat('eps_stress_rtol',defaultVal=0.01_pReal) eps_stress_rtol = num_grid%get_asFloat('eps_stress_rtol',defaultVal=0.01_pReal)
num_generic => numerics_root%get('generic',defaultVal=emptyDict) itmin = num_grid%get_asInt('itmin',defaultVal=1)
itmin = num_generic%get_asInt('itmin',defaultVal=1) itmax = num_grid%get_asInt('itmax',defaultVal=250)
itmax = num_generic%get_asInt('itmax',defaultVal=250)
if (eps_div_atol <= 0.0_pReal) call IO_error(301,ext_msg='eps_div_atol') if (eps_div_atol <= 0.0_pReal) call IO_error(301,ext_msg='eps_div_atol')
if (eps_div_rtol < 0.0_pReal) call IO_error(301,ext_msg='eps_div_rtol') if (eps_div_rtol < 0.0_pReal) call IO_error(301,ext_msg='eps_div_rtol')
@ -533,8 +528,7 @@ subroutine formResidual(in, FandF_tau, &
PetscObject :: dummy PetscObject :: dummy
PetscErrorCode :: ierr PetscErrorCode :: ierr
class(tNode), pointer :: & class(tNode), pointer :: &
num_grid, & num_grid
num_generic
real(pReal) :: & real(pReal) :: &
polarAlpha, & !< polarization scheme parameter 0.0 < alpha < 2.0. alpha = 1.0 ==> AL scheme, alpha = 2.0 ==> accelerated scheme polarAlpha, & !< polarization scheme parameter 0.0 < alpha < 2.0. alpha = 1.0 ==> AL scheme, alpha = 2.0 ==> accelerated scheme
polarBeta !< polarization scheme parameter 0.0 < beta < 2.0. beta = 1.0 ==> AL scheme, beta = 2.0 ==> accelerated scheme polarBeta !< polarization scheme parameter 0.0 < beta < 2.0. beta = 1.0 ==> AL scheme, beta = 2.0 ==> accelerated scheme
@ -547,10 +541,8 @@ subroutine formResidual(in, FandF_tau, &
num_grid => numerics_root%get('grid',defaultVal = emptyDict) num_grid => numerics_root%get('grid',defaultVal = emptyDict)
polarAlpha = num_grid%get_asFloat('polaralpha',defaultVal=1.0_pReal) polarAlpha = num_grid%get_asFloat('polaralpha',defaultVal=1.0_pReal)
polarBeta = num_grid%get_asFloat('polarbeta', defaultVal=1.0_pReal) polarBeta = num_grid%get_asFloat('polarbeta', defaultVal=1.0_pReal)
itmin = num_grid%get_asInt('itmin',defaultVal=1)
num_generic => numerics_root%get('generic',defaultVal=emptyDict) itmax = num_grid%get_asInt('itmax',defaultVal=250)
itmin = num_generic%get_asInt('itmin',defaultVal=1)
itmax = num_generic%get_asInt('itmax',defaultVal=250)
if (itmax <= 1) call IO_error(301,ext_msg='itmax') if (itmax <= 1) call IO_error(301,ext_msg='itmax')
if (itmin > itmax .or. itmin < 1) call IO_error(301,ext_msg='itmin') if (itmin > itmax .or. itmin < 1) call IO_error(301,ext_msg='itmin')

View File

@ -63,7 +63,7 @@ subroutine grid_thermal_spectral_init
PetscScalar, dimension(:,:,:), pointer :: x_scal PetscScalar, dimension(:,:,:), pointer :: x_scal
PetscErrorCode :: ierr PetscErrorCode :: ierr
class(tNode), pointer :: & class(tNode), pointer :: &
num_generic num_grid
character(len=pStringLen) :: & character(len=pStringLen) :: &
petsc_options petsc_options
@ -74,8 +74,8 @@ subroutine grid_thermal_spectral_init
!------------------------------------------------------------------------------------------------- !-------------------------------------------------------------------------------------------------
! read numerical parameter ! read numerical parameter
num_generic => numerics_root%get('generic',defaultVal=emptyDict) num_grid => numerics_root%get('grid',defaultVal=emptyDict)
petsc_options = num_generic%get_asString('petsc_options',defaultVal='') petsc_options = num_grid%get_asString('petsc_options',defaultVal='')
!-------------------------------------------------------------------------------------------------- !--------------------------------------------------------------------------------------------------
! set default and user defined options for PETSc ! set default and user defined options for PETSc
@ -147,7 +147,7 @@ function grid_thermal_spectral_solution(timeinc,timeinc_old) result(solution)
itmax !< maximum number of iterations itmax !< maximum number of iterations
type(tSolutionState) :: solution type(tSolutionState) :: solution
class(tNode), pointer :: & class(tNode), pointer :: &
num_generic num_grid
PetscInt :: devNull PetscInt :: devNull
PetscReal :: T_min, T_max, stagNorm, solnNorm PetscReal :: T_min, T_max, stagNorm, solnNorm
@ -156,8 +156,8 @@ function grid_thermal_spectral_solution(timeinc,timeinc_old) result(solution)
!------------------------------------------------------------------- !-------------------------------------------------------------------
! reading numerical parameter and do sanity check ! reading numerical parameter and do sanity check
num_generic => numerics_root%get('generic',defaultVal=emptyDict) num_grid => numerics_root%get('grid',defaultVal=emptyDict)
itmax = num_generic%get_asInt('itmax',defaultVal=250) itmax = num_grid%get_asInt('itmax',defaultVal=250)
if (itmax <= 1) call IO_error(301,ext_msg='itmax') if (itmax <= 1) call IO_error(301,ext_msg='itmax')
solution%converged =.false. solution%converged =.false.

View File

@ -192,8 +192,7 @@ subroutine spectral_utilities_init
character(len=pStringLen) :: & character(len=pStringLen) :: &
petsc_options petsc_options
class (tNode) , pointer :: & class (tNode) , pointer :: &
num_grid, & num_grid
num_generic
write(6,'(/,a)') ' <<<+- spectral_utilities init -+>>>' write(6,'(/,a)') ' <<<+- spectral_utilities init -+>>>'
@ -220,8 +219,8 @@ subroutine spectral_utilities_init
trim(PETScDebug), & trim(PETScDebug), &
' add more using the PETSc_Options keyword in numerics.config '; flush(6) ' add more using the PETSc_Options keyword in numerics.config '; flush(6)
num_generic => numerics_root%get('generic',defaultVal=emptyDict) num_grid => numerics_root%get('grid',defaultVal=emptyDict)
petsc_options = num_generic%get_asString('petsc_options',defaultVal='') petsc_options = num_grid%get_asString('petsc_options',defaultVal='')
call PETScOptionsClear(PETSC_NULL_OPTIONS,ierr) call PETScOptionsClear(PETSC_NULL_OPTIONS,ierr)
CHKERRQ(ierr) CHKERRQ(ierr)
@ -236,8 +235,6 @@ subroutine spectral_utilities_init
write(6,'(/,a,3(i12 ))') ' grid a b c: ', grid write(6,'(/,a,3(i12 ))') ' grid a b c: ', grid
write(6,'(a,3(es12.5))') ' size x y z: ', geomSize write(6,'(a,3(es12.5))') ' size x y z: ', geomSize
num_grid => numerics_root%get('grid',defaultVal=emptyDict)
num%memory_efficient = num_grid%get_asInt ('memory_efficient', defaultVal=1) > 0 num%memory_efficient = num_grid%get_asInt ('memory_efficient', defaultVal=1) > 0
num%FFTW_timelimit = num_grid%get_asFloat ('fftw_timelimit', defaultVal=-1.0_pReal) num%FFTW_timelimit = num_grid%get_asFloat ('fftw_timelimit', defaultVal=-1.0_pReal)
num%divergence_correction = num_grid%get_asInt ('divergence_correction', defaultVal=2) num%divergence_correction = num_grid%get_asInt ('divergence_correction', defaultVal=2)

View File

@ -60,7 +60,7 @@ program DAMASK_mesh
stagItMax, & !< max number of field level staggered iterations stagItMax, & !< max number of field level staggered iterations
component component
class(tNode), pointer :: & class(tNode), pointer :: &
num_generic num_mesh
character(len=pStringLen), dimension(:), allocatable :: fileContent character(len=pStringLen), dimension(:), allocatable :: fileContent
character(len=pStringLen) :: & character(len=pStringLen) :: &
incInfo, & incInfo, &
@ -80,9 +80,9 @@ program DAMASK_mesh
!--------------------------------------------------------------------- !---------------------------------------------------------------------
! reading field information from numerics file and do sanity checks ! reading field information from numerics file and do sanity checks
num_generic => numerics_root%get('generic', defaultVal=emptyDict) num_mesh => numerics_root%get('mesh', defaultVal=emptyDict)
stagItMax = num_generic%get_asInt('maxStaggeredIter',defaultVal=10) stagItMax = num_mesh%get_asInt('maxStaggeredIter',defaultVal=10)
maxCutBack = num_generic%get_asInt('maxCutBack',defaultVal=3) maxCutBack = num_mesh%get_asInt('maxCutBack',defaultVal=3)
if (stagItMax < 0) call IO_error(301,ext_msg='maxStaggeredIter') if (stagItMax < 0) call IO_error(301,ext_msg='maxStaggeredIter')
if (maxCutBack < 0) call IO_error(301,ext_msg='maxCutBack') if (maxCutBack < 0) call IO_error(301,ext_msg='maxCutBack')

View File

@ -103,8 +103,7 @@ subroutine FEM_utilities_init
character(len=pStringLen) :: petsc_optionsOrder character(len=pStringLen) :: petsc_optionsOrder
class(tNode), pointer :: & class(tNode), pointer :: &
num_mesh, & num_mesh
num_generic
integer :: structOrder !< order of displacement shape functions integer :: structOrder !< order of displacement shape functions
character(len=pStringLen) :: & character(len=pStringLen) :: &
petsc_options petsc_options
@ -114,9 +113,7 @@ subroutine FEM_utilities_init
num_mesh => numerics_root%get('mesh',defaultVal=emptyDict) num_mesh => numerics_root%get('mesh',defaultVal=emptyDict)
structOrder = num_mesh%get_asInt('structOrder',defaultVal = 2) structOrder = num_mesh%get_asInt('structOrder',defaultVal = 2)
petsc_options = num_mesh%get_asString('petsc_options', defaultVal='')
num_generic => numerics_root%get('generic',defaultVal=emptyDict)
petsc_options = num_generic%get_asString('petsc_options', defaultVal='')
!-------------------------------------------------------------------------------------------------- !--------------------------------------------------------------------------------------------------
! set debugging parameters ! set debugging parameters

View File

@ -96,8 +96,7 @@ subroutine FEM_mech_init(fieldBC)
PetscErrorCode :: ierr PetscErrorCode :: ierr
class(tNode), pointer :: & class(tNode), pointer :: &
num_mesh, & num_mesh
num_generic
integer :: & integer :: &
integrationOrder, & !< order of quadrature rule required integrationOrder, & !< order of quadrature rule required
itmax itmax
@ -109,8 +108,8 @@ subroutine FEM_mech_init(fieldBC)
num_mesh => numerics_root%get('mesh',defaultVal=emptyDict) num_mesh => numerics_root%get('mesh',defaultVal=emptyDict)
integrationOrder = num_mesh%get_asInt('integrationorder',defaultVal = 2) integrationOrder = num_mesh%get_asInt('integrationorder',defaultVal = 2)
num_generic => numerics_root%get('generic',defaultVal=emptyDict) num_mesh => numerics_root%get('mesh',defaultVal=emptyDict)
itmax = num_generic%get_asInt('itmax',defaultVal=250) itmax = num_mesh%get_asInt('itmax',defaultVal=250)
if (itmax <= 1) call IO_error(301,ext_msg='itmax') if (itmax <= 1) call IO_error(301,ext_msg='itmax')
!-------------------------------------------------------------------------------------------------- !--------------------------------------------------------------------------------------------------
@ -286,15 +285,15 @@ type(tSolutionState) function FEM_mech_solution( &
integer :: & integer :: &
itmax itmax
class(tNode), pointer :: & class(tNode), pointer :: &
num_generic num_mesh
PetscErrorCode :: ierr PetscErrorCode :: ierr
SNESConvergedReason :: reason SNESConvergedReason :: reason
!-------------------------------------------------------------------------------------------------- !--------------------------------------------------------------------------------------------------
! read numerical parameter and do sanity check ! read numerical parameter and do sanity check
num_generic => numerics_root%get('generic',defaultVal=emptyDict) num_mesh => numerics_root%get('mesh',defaultVal=emptyDict)
itmax = num_generic%get_asInt('itmax',defaultVal=250) itmax = num_mesh%get_asInt('itmax',defaultVal=250)
if (itmax <= 1) call IO_error(301,ext_msg='itmax') if (itmax <= 1) call IO_error(301,ext_msg='itmax')
!------------------------------------------------------------------------------------------------- !-------------------------------------------------------------------------------------------------