Run time Error for Miss Files

Numerical methods and mathematical models of Elmer
Post Reply
hemi
Posts: 2
Joined: 16 May 2018, 06:58
Antispam: Yes

Run time Error for Miss Files

Post by hemi »

I used ElmerSolver to solve a motor model on Windows, however I got following message, after I run it like this ElmerSolver case_PMSM.sif.

Code: Select all

MAIN: =============================================================
MAIN: ElmerSolver finite element software, Welcome!
MAIN: This program is free software licensed under (L)GPL
MAIN: Copyright 1st April 1995 - , CSC - IT Center for Science Ltd.
MAIN: Webpage http://www.csc.fi/elmer, Email elmeradm@csc.fi
MAIN: Version: 8.3 (Rev: c30fff2, Compiled: 2017-05-22)
MAIN: =============================================================
MAIN:
MAIN:
MAIN: -------------------------------------
MAIN: Reading Model: case_PMSM.sif
LoadInputFile: Scanning input file: case_PMSM.sif
LoadInputFile: Loading input file: case_PMSM.sif
Model Input:  Unlisted keyword: [interpolation numeric epsilon] in section: [simulation]
WARNING:: CheckTimer: Requesting time from non-existing timer: LoadMesh
WARNING:: CheckTimer: Requesting time from non-existing timer: MeshStabParams
MAIN:
MAIN: -------------------------------------
MAIN:  Time: 1/31   5.5555555555599997E-005
MAIN: -------------------------------------
MAIN:
WARNING:: CheckTimer: Requesting time from non-existing timer: PeriodicProjector
ComputeChange: NS (ITER=1) (NRM,RELC): (  789.60095      2.0000000     ) :: mgdyn2d
ComputeChange: NS (ITER=2) (NRM,RELC): (  76808.333      1.9592978     ) :: mgdyn2d
ComputeChange: NS (ITER=3) (NRM,RELC): (  53298.419     0.36139423     ) :: mgdyn2d
ComputeChange: NS (ITER=4) (NRM,RELC): (  34045.778     0.44084533     ) :: mgdyn2d
ComputeChange: NS (ITER=5) (NRM,RELC): (  23740.023     0.35668813     ) :: mgdyn2d
ComputeChange: NS (ITER=6) (NRM,RELC): (  19702.540     0.18587686     ) :: mgdyn2d
ComputeChange: NS (ITER=7) (NRM,RELC): (  18740.745     0.50037077E-01 ) :: mgdyn2d
ComputeChange: NS (ITER=8) (NRM,RELC): (  18601.998     0.74310180E-02 ) :: mgdyn2d
ComputeChange: NS (ITER=9) (NRM,RELC): (  18567.777     0.18413230E-02 ) :: mgdyn2d
ComputeChange: NS (ITER=10) (NRM,RELC): (  18555.331     0.67054142E-03 ) :: mgdyn2d
ComputeChange: NS (ITER=11) (NRM,RELC): (  18551.863     0.18690433E-03 ) :: mgdyn2d
ComputeChange: NS (ITER=12) (NRM,RELC): (  18552.670     0.43512385E-04 ) :: mgdyn2d
ComputeChange: NS (ITER=13) (NRM,RELC): (  18553.008     0.18193638E-04 ) :: mgdyn2d
ComputeChange: NS (ITER=14) (NRM,RELC): (  18553.046     0.20735675E-05 ) :: mgdyn2d
ComputeChange: NS (ITER=15) (NRM,RELC): (  18553.047     0.60775359E-07 ) :: mgdyn2d
ComputeChange: NS (ITER=1) (NRM,RELC): ( 0.83499318      2.0000000     ) :: mgdyn2dpost
ComputeChange: NS (ITER=2) (NRM,RELC): ( 0.53122223     0.44468969     ) :: mgdyn2dpost
At line 986 of file c:/ElmerBuild/src/elmer/elmerfem/fem/src/modules/ResultOutputSolve/VtuOutputSolver.F90 (unit = 58, file = '?')
Fortran runtime error: File 'results/./step0001.vtu' does not exist
mzenker
Posts: 1999
Joined: 07 Dec 2009, 11:49
Location: Germany

Re: Run time Error for Miss Files

Post by mzenker »

Hi,

could you post the sif file?

Matthias
hemi
Posts: 2
Joined: 16 May 2018, 06:58
Antispam: Yes

Re: Run time Error for Miss Files

Post by hemi »

mzenker wrote:Hi,

could you post the sif file?

Matthias
The content is this. Thanks.

Code: Select all

! PMSM 2D Magneto-Static Simulation
! Parameters
$ w_m = 3000/60*2*pi ! [rad/s mech.] mechanical frequency
$ pp = 2 ! number of polepairs
$ w_el = w_m*pp ! [rad/s el.] electrical frequency
$ B_PM = 1.17 ! [T] remanent flux density
$ mu_PM = 1.06 ! relative permeability of PMs
$ H_PM = B_PM/(mu_PM*pi*4d-7) ! [A/m] magnetization of PMs
$ Id = 0 ! [A] d-axis current
$ Iq = 0 ! [A] q-axis current
$ Nph = 186 ! Number of phase turns
$ Scs = 0.00154555 ! [m^2] area of the coil side
Header
CHECK KEYWORDS Warn
Mesh DB "PMSM" "."
Include Path ""
Results Directory "results"
End
Constants
Permittivity of Vacuum = 8.8542e-12
End
Simulation
Max Output Level = 3
Coordinate System = Cartesian
Coordinate Scaling = 0.001
Simulation Type = Transient
Timestepping Method = BDF
BDF Order = 2
Timestep Sizes = $ 1/(w_el/2/pi)/6/30! 180 samples per el. period
Timestep Intervals = 31
Output Intervals = 1
!!!!!!!! mesh interpolation tolerances
Interpolation Numeric Epsilon = Real 5.0e-9
End
!!!!!!!!!!!!!!!!!!!!!!!!!! Materials !!!!!!!!!!!!!!!!!!!!!!!!!!!
Material 1
Name = "Air"
Relative Permeability = 1
End
Material 2
Name = "Iron"
! actually B-H values are in the file BH (name is H-B, but values are in B-H format)
H-B Curve = Variable coupled iter
Real Monotone Cubic
Include BH
End
End
Material 3
Name = "PM_right"
Relative Permeability = $ mu_PM
Magnetization 1 = Variable time, timestep size
Real MATC "H_PM*cos(w_m*(tx(0)-tx(1)))"
Magnetization 2 = Variable time, timestep size
Real MATC "H_PM*sin(w_m*(tx(0)-tx(1)))"
End
Material 4
Name = "PM_up"
Relative Permeability = $ mu_PM
Magnetization 1 = Variable time, timestep size
Real MATC "-H_PM*sin(w_m*(tx(0)-tx(1)))"
Magnetization 2 = Variable time, timestep size
Real MATC "H_PM*cos(w_m*(tx(0)-tx(1)))"
End
Material 5
Name = "PM_left"
Relative Permeability = $ mu_PM
Magnetization 1 = Variable time, timestep size
Real MATC "-H_PM*cos(w_m*(tx(0)-tx(1)))"
Magnetization 2 = Variable time, timestep size
Real MATC "-H_PM*sin(w_m*(tx(0)-tx(1)))"
End
Material 6
Name = "PM_down"
Relative Permeability = $ mu_PM
Magnetization 1 = Variable time, timestep size
Real MATC "H_PM*sin(w_m*(tx(0)-tx(1)))"
Magnetization 2 = Variable time, timestep size
Real MATC "-H_PM*cos(w_m*(tx(0)-tx(1)))"
End
Material 7
Name = "Wedge"
Relative Permeability = 1
End
!!!!!!!!!!!!!!!!!!!!!!!!!! Boundary conditions !!!!!!!!!!!!!!!!!!!!!!!!!!!
!outer boundary Dirichlet
Boundary Condition 1
Target Boundaries(1) = 1
Name = "Boundary_Outer"
Potential Condition = 0
Potential = 0
End
Boundary Condition 2
Target Boundaries(1) = 2
Name = "Sliding"
Discontinuous Boundary = Logical True
Save Line = True
Mortar BC = 3
End
!!!!!!!!!!!!!!!!!!!!!!!!!! Body Forces !!!!!!!!!!!!!!!!!!!!!!!!!!!
!rotation of the rotor
Body Force 1
Name = "BodyForce_Rotation"
Mesh Rotate 3 = Variable time, timestep size
Real MATC "180/pi*w_m*(tx(0)-tx(1))" ! in degrees
End
!!!!!!!!!!!!!!!!!!!!!!!!!! Solver parameters !!!!!!!!!!!!!!!!!!!!!!!!!!!
!mesh rotation
Solver 1
Exec Solver = Before Timestep
Equation = MeshDeform
Procedure = "RigidMeshMapper" "RigidMeshMapper"
End
! solver for magnetic vector potential A [Vs/m]
Solver 2
Equation = MgDyn2D
Procedure = "MagnetoDynamics2D" "MagnetoDynamics2D"
Exec Solver = Always
Nonlinear System Convergence Tolerance = 1.0e-6
Nonlinear System Max Iterations = 20
Nonlinear System Relaxation Factor = 1
Linear System Solver = Direct
Linear System Direct Method = UMFPACK
End
!solver for magnetic flux density B [T]
!does not require settings for nonlinear solver
Solver 3
Equation = MgDyn2DPost
Procedure = "MagnetoDynamics2D" "BSolver"
Exec Solver = After Timestep
Linear System Solver = Direct
Linear System Direct Method = UMFPACK
Discontinuous Galerkin = True
Average Within Materials = False
End
!save to VTU format for ParaView with faces' IDs
Solver 4
Exec Solver = After Timestep
Procedure = "ResultOutputSolve" "ResultOutputSolver"
Output File Name = "step"
Vtu Format = True
Binary Output = True
Single Precision = True
Save Geometry Ids = True
End
!save scalar variables - torque T [Nm]
Solver 5
Exec Solver = After Timestep
Filename = "scalars.dat"
Procedure = "SaveData" "SaveScalars"
Show Norm Index = 1
End
Equation 1
Name = "ModelDomain"
Active Solvers(5) = 1 2 3 4 5
End
!!!!!!!!!!!!!!!!!!!!!!!!!! Bodies are here !!!!!!!!!!!!!!!!!!!!!!!!!!!
Body 1
Target Bodies(1) = 1
Name = "U+"
Equation = 1
Material = 1
End
Body 2
Target Bodies(1) = 2
Name = "U-"
Equation = 1
Material = 1
End
Body 3
Target Bodies(1) = 3
Name = "V+"
Equation = 1
Material = 1
End
Body 4
Target Bodies(1) = 4
Name = "V-"
Equation = 1
Material = 1
End
Body 5
Target Bodies(1) = 5
Name = "W+"
Equation = 1
Material = 1
End
Body 6
Target Bodies(1) = 6
Name = "W-"
Equation = 1
Material = 1
End
Body 7
Target Bodies(1) = 7
Name = "stator lamination"
Equation = 1
Material = 2
End
Body 8
Target Bodies(1) = 8
Name = "rotor lamination"
Equation = 1
Material = 2
Body Force = 1
End
Body 9
Target Bodies(1) = 9
Name = "wedges"
Equation = 1
Material = 7
End
Body 10
Target Bodies(1) = 10
Name = "shaft"
Equation = 1
Material = 1
Body Force = 1
End
Body 11
Target Bodies(1) = 11
Name = "PM1"
Equation = 1
Material = 3
Body Force = 1
End
Body 12
Target Bodies(1) = 12
Name = "PM2"
Equation = 1
Material = 6
Body Force = 1
End
Body 13
Target Bodies(1) = 13
Name = "PM3"
Equation = 1
Material = 5
Body Force = 1
End
Body 14
Target Bodies(1) = 14
Name = "PM4"
Equation = 1
Material = 4
Body Force = 1
End
Body 15
Target Bodies(1) = 15
Name = "stator airgap"
Equation = 1
Material = 1
End
Body 16
Target Bodies(1) = 16
Name = "rotor airgap"
Equation = 1
Material = 1
Body Force = 1
r outer = Real 0.0406
r inner = Real 0.040
End
Post Reply