Squashed version of Will's commits.

This commit is contained in:
Sachith Dunatunga
2024-12-09 08:31:57 -08:00
parent cd16308d71
commit 00ebe9a3e8
30 changed files with 22983 additions and 30 deletions

View File

@ -0,0 +1,46 @@
# Building the executable:
-------------------------------------------------------------------------------
CMAKE may be used to build the executable, below is a short shell script that builds a fresh version of the executable.
#!/bin/bash
rm -r build
mkdir build; cd build
cmake ../cmake
PKGS="-D PKG_GRANULAR=on -D PKG_VTK=on -D PKG_SRD=on -D PKG_MPI=on"
cmake -C ../cmake/presets/most.cmake -C ../cmake/presets/nolib.cmake $PKGS ../cmake
cmake --build . -- -j 10
The GRANULAR package allows DEM simulation in LAMMPS and the VTK package allows creation of VTK files for viewing in paraview. The SRD package is for fluid coupling and the MPI is for parallelization. There are various other ways to build the lammps executable if you are interested: https://docs.lammps.org/Build.html.
# Running the code:
-------------------------------------------------------------------------------
In the sims directory of the code base there is a folder called avicelTableting. Inside there is an input file called in.avicelTableting200. This input file defines a tableting simulation that is composed of die filling, compaction, release, and ejection. The geometry of the simulation is modeled after a real compaction simulator die. The material properties that are set roughly represent Avicel PH102. To run this simulation in serial, navigate inside the avicelTableting folder and run the following command:
(path to lmp executable) < in.avicelTableting200
The simulation consists of 200 particles and takes ~10 minutes to run on a 2021 M1 Max. To generate a new packing with particles of different radii or distribution you can use the matlab script within generatePackings called generateCylinderPacking.m. It allows you to define the cylinder size, number of desired particles, minimum radius, and maximum radius. It will then generate a packing called spheres.data that is saved in the avicelTableting folder. If you change the distribution of the particle packing make sure to update the following items in the input script:
neighbor - should be ~1.5x greater than the max radius Rmax.
timestep - dt = 0.35*sqrt{m/k} = 0.35*sqrt{(rho*4/3*pi*Rmin^3)/(kappa*Rmin)}.
variable atomRadius - specified value in front of prefactor should match Rmin from generateCylinderPacking.m.
Once running the program should output three files a dump file and two csv files. The dump file can be used in Ovito for visualization. If you desire vtk files for visualization in Paraview create a folder called post and uncomment the dump command in in.avicelTableting. The generated csv files contain the upper punch displacement force relation and particle stress information.
Plots of the axial stress and radial stress versus displacement can be generated using the matlab script avicelTabletingPlotStresses.m. The script will work even while the simulation is in the middle of running and is a good way to check on the status of the simulation.
The other input script in the folder is in.avicelTableting20000 this 20,000 particle simulation is the exact one presented in Zunker et al., 2024 and is most efficiently run in parallel with the following command:
mpirun --np 4 (path to lmp executable) -in in.avicelTableting20000
Anticipate this simulation to take longer to run, on a 2021 M1 Max running in parallel on 4 processors the simulation took 28 hours to complete.
Also within the sims directory is the MPFEM folder, which contains two small simulations involving the compaction of 14 monodisperse particles and 12 tridisperse particles as described in Zunker et al., 2024. The input files for these simulations can then be run using the following commands:
(path to lmp executable) < in.triaxial14particles
(path to lmp executable) < in.triaxial12particles
The outputs of each of these simulations are a dump file and a .csv containing the measured forces in each principal direction. To visualize the measured stresses you can run the Matlab script macro_stresses.m. This will plot stresses for both the LAMMPS results and data from corresponding FEM simulations. The Abaqus 2022 input files for the monodisperse and tridisperse FEM are included in the folder as MPFEM.inp and MPFEM_diff_radii.inp, respectively. For convenience, the principal stress output data for these FEM simulations is already included in the folder as fem.mat and fem_diff_radii.mat.

View File

@ -0,0 +1,184 @@
############################### SIMULATION SETTINGS ###################################################
atom_style sphere 1
atom_modify map array
comm_modify vel yes
units si
newton off
neighbor 1.0e-3 bin
neigh_modify every 10 delay 2000 check no
timestep 1.35e-7
#processors 2 2 1
######################### SIMULATION BOUNDING BOX, INTEGRATION, AND, GRAVITY ###########################
boundary f f f
read_data spheres200.data
######################################### ADD DIE AND ATOM PARAMETERIZATION ##############################################
variable atomRadius equal 0.44e-3*1.25
variable atomDiameter equal 2*${atomRadius}
variable atomDensity equal 1560
variable atomMassAvg equal ${atomDensity}*4.0/3.0*PI*${atomRadius}^3.0
variable dieRadius equal 4e-3
variable dieHeight equal 1e-2
########################### PARTICLE MATERIAL PROPERTIES AND FORCE MODEL ###############################
pair_style granular
# mdr = E, nu, Y, gamma, psi_b, CoR
# linear_history = k_t, x_gamma,t, mu_s
variable YoungsModulus equal 5e9
variable YieldStress equal 1.9e8
variable PoissonsRatio equal 0.4
variable SurfaceEnergy equal 2000
variable SurfaceEnergyWall equal 0.0
variable CoR equal 0.5
variable psi_b equal 0.5
variable beta equal -ln(${CoR})/sqrt(ln(${CoR})^2+PI^2)
variable kt equal 2/7*${YoungsModulus}*${atomRadius}
variable kt_wall equal 2/7*${YoungsModulus}*${atomRadius}
variable xgammat equal 0.0 #${beta}*sqrt(${atomMassAvg}*${YoungsModulus}*${atomRadius})
variable mu_s equal 0.7
variable mu_s_wall equal 0.1
variable mu_roll equal 0.6
variable k_roll equal 2.25*${mu_roll}*${mu_roll}*${YoungsModulus}*${atomRadius}
variable gamma_roll equal 0.0 #${beta}*sqrt(${atomMassAvg}*${YoungsModulus}*${atomRadius})
pair_coeff * * mdr ${YoungsModulus} ${PoissonsRatio} ${YieldStress} ${SurfaceEnergy} ${psi_b} ${CoR} damping none tangential linear_history ${kt} ${xgammat} ${mu_s} rolling sds ${k_roll} ${gamma_roll} ${mu_roll}
#pair_coeff * * mdr ${YoungsModulus} ${PoissonsRatio} ${YieldStress} ${SurfaceEnergy} ${psi_b} ${CoR} tangential linear_history ${kt} ${xgammat} ${mu_s} damping none
#pair_coeff * * mdr ${YoungsModulus} ${PoissonsRatio} ${YieldStress} ${SurfaceEnergy} ${psi_b} ${CoR} tangential linear_nohistory 0.0 0.0 damping none
######################################### ADD DIE AND PUNCH WALLS ################################################
variable disp_upper equal 0.0
variable disp_lower equal 0.0
variable disp_xPlanePos equal 0.0
variable disp_xPlaneNeg equal 0.0
variable wall_contact_string string "granular mdr ${YoungsModulus} ${PoissonsRatio} ${YieldStress} ${SurfaceEnergyWall} ${psi_b} ${CoR} damping none tangential linear_history ${kt_wall} ${xgammat} ${mu_s_wall} rolling sds ${k_roll} ${gamma_roll} ${mu_roll}"
#variable wall_contact_string string "granular mdr ${YoungsModulus} ${PoissonsRatio} ${YieldStress} ${SurfaceEnergyWall} ${psi_b} ${CoR} tangential linear_history ${kt} ${xgammat} ${mu_s} damping none"
#variable wall_contact_string string "granular mdr ${YoungsModulus} ${PoissonsRatio} ${YieldStress} ${SurfaceEnergyWall} ${psi_b} ${CoR} tangential linear_nohistory 0.0 0.0 damping none"
variable dieHeight2 equal 2*${dieHeight}
region lowerPunch plane 0 0 0 0 0 1 side in units box move NULL NULL v_disp_lower units box
region upperPunch plane 0 0 ${dieHeight} 0 0 -1 side in move NULL NULL v_disp_upper units box
region die cylinder z 0 0 ${dieRadius} 0 ${dieHeight2} side in units box
variable dieRadiusPlus equal ${dieRadius}*1.05
variable dieRadiusPlusNeg equal -${dieRadiusPlus}
region xPlanePos plane ${dieRadiusPlus} 0 0 -1 0 0 side in units box move v_disp_xPlanePos NULL NULL units box
region xPlaneNeg plane ${dieRadiusPlusNeg} 0 0 1 0 0 side in units box move v_disp_xPlaneNeg NULL NULL units box
fix lowerPunch all wall/gran/region ${wall_contact_string} region lowerPunch contacts
fix upperPunch all wall/gran/region ${wall_contact_string} region upperPunch contacts
fix die all wall/gran/region ${wall_contact_string} region die contacts
fix xPlanePos all wall/gran/region ${wall_contact_string} region xPlanePos contacts
fix xPlaneNeg all wall/gran/region ${wall_contact_string} region xPlaneNeg contacts
compute avgPunchForce all reduce sum f_upperPunch[4]
variable avgPunchForce equal c_avgPunchForce
compute avgLowerPunchForce all reduce sum f_lowerPunch[4]
variable avgLowerPunchForce equal c_avgLowerPunchForce
compute fractureForce all reduce sum f_xPlanePos[2]
variable fractureForce equal c_fractureForce
fix print1 all print 1 "${disp_upper} ${avgPunchForce} ${avgLowerPunchForce} ${fractureForce}" file upperPunchDispForce.csv screen no
fix printSTL all print 1 "${disp_upper} ${disp_lower}" file punch_disp_STL_generation.csv screen no
##################################### INSERT PARTICLES ####################################################
fix 1 all nve/sphere
fix grav all gravity 9.81 vector 0 0 -1
######################################## SCREEN OUTPUT ####################################################
#variable ax atom fx/mass
#variable ay atom fy/mass
#variable az atom fz/mass
#variable aMag atom sqrt(v_ax*v_ax+v_ay*v_ay+v_az*v_az)
#variable force atom sqrt(fx^2+fy^2+fz^2)
#compute aMagAvg all reduce ave v_aMag
#variable forceToAccelRatio atom v_force/(mass*v_aMag)
compute 1 all erotate/sphere
thermo_style custom dt step atoms ke vol v_disp_upper #c_aMagAvg
thermo 100
thermo_modify lost ignore norm no
##################################### SET UP DUMP OUTPUTS ####################################################
compute ke all ke/atom
variable output_rate equal round(1e-3/dt)
#variable output_rate equal 10
#dump 1 all custom 1 uniaxialCompression id type f_plane_yz_neg[*]
#variable az_upperPunch atom f_upperPunch[7]
#variable afz_upperPunch atom f_upperPunch[4]
#fix log all print 1 "${delta} ${fx_neg}" file uniaxialCompression.csv title "del,fx_yz_neg" screen no
run 0
compute sigmaxx all property/atom d_sigmaxx
compute sigmayy all property/atom d_sigmayy
compute sigmazz all property/atom d_sigmazz
compute Velas all property/atom d_Velas
compute adhesive_length all property/atom d_adhesive_length
compute sigmaxx_ave all reduce ave c_sigmaxx
compute sigmayy_ave all reduce ave c_sigmayy
compute sigmazz_ave all reduce ave c_sigmazz
compute Velas_sum all reduce sum c_Velas
compute adhesive_length_ave all reduce ave c_adhesive_length
variable sxx_ave equal c_sigmaxx_ave
variable syy_ave equal c_sigmayy_ave
variable szz_ave equal c_sigmazz_ave
variable Vparticles equal c_Velas_sum
variable adh_length_ave equal c_adhesive_length_ave
fix log all print 1 "${sxx_ave} ${syy_ave} ${szz_ave} ${Vparticles} ${adh_length_ave}" file avgStresses.csv screen no
dump dumpParticles all custom ${output_rate} avicelTableting.dump id type mass diameter x y z vx vy vz fx fy fz c_ke c_sigmaxx c_sigmayy c_sigmazz #v_aMag v_force v_forceToAccelRatio
#dump dumpParticlesVTK all vtk ${output_rate} post/particles_*.vtk id x y z fx fy fz vx vy vz c_ke radius c_sigmaxx c_sigmayy c_sigmazz
######################################### RUN SIMULATION ##########################################
variable upper_punch_stroke equal 0.6733*${dieHeight} # 0.6733
variable vel_upper equal 0.25
variable settling_steps equal round(0.02/dt)
variable compression_steps equal 2*round(${upper_punch_stroke}/${vel_upper}/dt)
variable ejection_steps equal ${compression_steps}
variable free_float_steps equal round(0.02/dt)
variable total_steps equal ${settling_steps}+${compression_steps}+${ejection_steps}+${free_float_steps}
print "Total steps = ${total_steps}"
##### SETTLING #####
run ${settling_steps}
##### Compression & Release #####
variable punch_frequency equal PI/2/(dt*${compression_steps}/2)
variable disp_upper equal -${upper_punch_stroke}*sin(${punch_frequency}*elapsed*dt)
variable short_release equal round(${compression_steps}*1.0)
run ${short_release} # 189170 upto #
##### EJECTION #####
variable punch_frequency equal PI/2/(dt*${ejection_steps})
variable disp_lower equal ${dieHeight}*sin(${punch_frequency}*elapsed*dt)
variable disp_upper equal 0.9*v_disp_lower
run ${ejection_steps}
##### FREE FLOAT #####
variable disp_lower equal ${dieHeight}
variable disp_upper equal ${dieHeight}*0.9
variable max_disp equal ${dieRadius}*0.75
#variable disp_xPlanePos equal -${max_disp}*elapsed/${free_float_steps}
#variable disp_xPlaneNeg equal -v_disp_xPlanePos
run ${free_float_steps}

View File

@ -0,0 +1,184 @@
############################### SIMULATION SETTINGS ###################################################
atom_style sphere 1
atom_modify map array
comm_modify vel yes
units si
newton off
neighbor 0.22e-3 bin
neigh_modify every 10 delay 2000 check no
timestep 0.3e-7
processors 2 2 1
######################### SIMULATION BOUNDING BOX, INTEGRATION, AND, GRAVITY ###########################
boundary f f f
read_data spheres.data
######################################### ADD DIE AND ATOM PARAMETERIZATION ##############################################
variable atomRadius equal 0.0961e-3*1.25
variable atomDiameter equal 2*${atomRadius}
variable atomDensity equal 1560
variable atomMassAvg equal ${atomDensity}*4.0/3.0*PI*${atomRadius}^3.0
variable dieRadius equal 4e-3
variable dieHeight equal 1e-2
########################### PARTICLE MATERIAL PROPERTIES AND FORCE MODEL ###############################
pair_style granular
# mdr = E, nu, Y, gamma, psi_b, CoR
# linear_history = k_t, x_gamma,t, mu_s
variable YoungsModulus equal 5e9
variable YieldStress equal 1.9e8
variable PoissonsRatio equal 0.4
variable SurfaceEnergy equal 450
variable SurfaceEnergyWall equal 0.0
variable CoR equal 0.5
variable psi_b equal 0.5
variable beta equal -ln(${CoR})/sqrt(ln(${CoR})^2+PI^2)
variable kt equal 2/7*${YoungsModulus}*${atomRadius}
variable kt_wall equal 2/7*${YoungsModulus}*${atomRadius}
variable xgammat equal 0.0 #${beta}*sqrt(${atomMassAvg}*${YoungsModulus}*${atomRadius})
variable mu_s equal 0.7
variable mu_s_wall equal 0.1
variable mu_roll equal 0.6
variable k_roll equal 2.25*${mu_roll}*${mu_roll}*${YoungsModulus}*${atomRadius}
variable gamma_roll equal 0.0 #${beta}*sqrt(${atomMassAvg}*${YoungsModulus}*${atomRadius})
pair_coeff * * mdr ${YoungsModulus} ${PoissonsRatio} ${YieldStress} ${SurfaceEnergy} ${psi_b} ${CoR} damping none tangential linear_history ${kt} ${xgammat} ${mu_s} rolling sds ${k_roll} ${gamma_roll} ${mu_roll}
#pair_coeff * * mdr ${YoungsModulus} ${PoissonsRatio} ${YieldStress} ${SurfaceEnergy} ${psi_b} ${CoR} tangential linear_history ${kt} ${xgammat} ${mu_s} damping none
#pair_coeff * * mdr ${YoungsModulus} ${PoissonsRatio} ${YieldStress} ${SurfaceEnergy} ${psi_b} ${CoR} tangential linear_nohistory 0.0 0.0 damping none
######################################### ADD DIE AND PUNCH WALLS ################################################
variable disp_upper equal 0.0
variable disp_lower equal 0.0
variable disp_xPlanePos equal 0.0
variable disp_xPlaneNeg equal 0.0
variable wall_contact_string string "granular mdr ${YoungsModulus} ${PoissonsRatio} ${YieldStress} ${SurfaceEnergyWall} ${psi_b} ${CoR} damping none tangential linear_history ${kt_wall} ${xgammat} ${mu_s_wall} rolling sds ${k_roll} ${gamma_roll} ${mu_roll}"
#variable wall_contact_string string "granular mdr ${YoungsModulus} ${PoissonsRatio} ${YieldStress} ${SurfaceEnergyWall} ${psi_b} ${CoR} tangential linear_history ${kt} ${xgammat} ${mu_s} damping none"
#variable wall_contact_string string "granular mdr ${YoungsModulus} ${PoissonsRatio} ${YieldStress} ${SurfaceEnergyWall} ${psi_b} ${CoR} tangential linear_nohistory 0.0 0.0 damping none"
variable dieHeight2 equal 2*${dieHeight}
region lowerPunch plane 0 0 0 0 0 1 side in units box move NULL NULL v_disp_lower units box
region upperPunch plane 0 0 ${dieHeight} 0 0 -1 side in move NULL NULL v_disp_upper units box
region die cylinder z 0 0 ${dieRadius} 0 ${dieHeight2} side in units box
variable dieRadiusPlus equal ${dieRadius}*1.05
variable dieRadiusPlusNeg equal -${dieRadiusPlus}
region xPlanePos plane ${dieRadiusPlus} 0 0 -1 0 0 side in units box move v_disp_xPlanePos NULL NULL units box
region xPlaneNeg plane ${dieRadiusPlusNeg} 0 0 1 0 0 side in units box move v_disp_xPlaneNeg NULL NULL units box
fix lowerPunch all wall/gran/region ${wall_contact_string} region lowerPunch contacts
fix upperPunch all wall/gran/region ${wall_contact_string} region upperPunch contacts
fix die all wall/gran/region ${wall_contact_string} region die contacts
fix xPlanePos all wall/gran/region ${wall_contact_string} region xPlanePos contacts
fix xPlaneNeg all wall/gran/region ${wall_contact_string} region xPlaneNeg contacts
compute avgPunchForce all reduce sum f_upperPunch[4]
variable avgPunchForce equal c_avgPunchForce
compute avgLowerPunchForce all reduce sum f_lowerPunch[4]
variable avgLowerPunchForce equal c_avgLowerPunchForce
compute fractureForce all reduce sum f_xPlanePos[2]
variable fractureForce equal c_fractureForce
fix print1 all print 1 "${disp_upper} ${avgPunchForce} ${avgLowerPunchForce} ${fractureForce}" file upperPunchDispForce.csv screen no
fix printSTL all print 1 "${disp_upper} ${disp_lower}" file punch_disp_STL_generation.csv screen no
##################################### INSERT PARTICLES ####################################################
fix 1 all nve/sphere
fix grav all gravity 9.81 vector 0 0 -1
######################################## SCREEN OUTPUT ####################################################
#variable ax atom fx/mass
#variable ay atom fy/mass
#variable az atom fz/mass
#variable aMag atom sqrt(v_ax*v_ax+v_ay*v_ay+v_az*v_az)
#variable force atom sqrt(fx^2+fy^2+fz^2)
#compute aMagAvg all reduce ave v_aMag
#variable forceToAccelRatio atom v_force/(mass*v_aMag)
compute 1 all erotate/sphere
thermo_style custom dt step atoms ke vol v_disp_upper #c_aMagAvg
thermo 100
thermo_modify lost ignore norm no
##################################### SET UP DUMP OUTPUTS ####################################################
compute ke all ke/atom
variable output_rate equal round(1e-4/dt)
#variable output_rate equal 10
#dump 1 all custom 1 uniaxialCompression id type f_plane_yz_neg[*]
#variable az_upperPunch atom f_upperPunch[7]
#variable afz_upperPunch atom f_upperPunch[4]
#fix log all print 1 "${delta} ${fx_neg}" file uniaxialCompression.csv title "del,fx_yz_neg" screen no
run 0
compute sigmaxx all property/atom d_sigmaxx
compute sigmayy all property/atom d_sigmayy
compute sigmazz all property/atom d_sigmazz
compute Velas all property/atom d_Velas
compute adhesive_length all property/atom d_adhesive_length
compute sigmaxx_ave all reduce ave c_sigmaxx
compute sigmayy_ave all reduce ave c_sigmayy
compute sigmazz_ave all reduce ave c_sigmazz
compute Velas_sum all reduce sum c_Velas
compute adhesive_length_ave all reduce ave c_adhesive_length
variable sxx_ave equal c_sigmaxx_ave
variable syy_ave equal c_sigmayy_ave
variable szz_ave equal c_sigmazz_ave
variable Vparticles equal c_Velas_sum
variable adh_length_ave equal c_adhesive_length_ave
fix log all print 1 "${sxx_ave} ${syy_ave} ${szz_ave} ${Vparticles} ${adh_length_ave}" file avgStresses.csv screen no
dump dumpParticles all custom ${output_rate} avicelTableting.dump id type mass diameter x y z vx vy vz fx fy fz c_ke c_sigmaxx c_sigmayy c_sigmazz #v_aMag v_force v_forceToAccelRatio
#dump dumpParticlesVTK all vtk ${output_rate} post/particles_*.vtk id x y z fx fy fz vx vy vz c_ke radius c_sigmaxx c_sigmayy c_sigmazz
######################################### RUN SIMULATION ##########################################
variable upper_punch_stroke equal 0.6905*${dieHeight} # 0.6733
variable vel_upper equal 0.25
variable settling_steps equal round(0.02/dt)
variable compression_steps equal 2*round(${upper_punch_stroke}/${vel_upper}/dt)
variable ejection_steps equal ${compression_steps}
variable free_float_steps equal round(0.02/dt)
variable total_steps equal ${settling_steps}+${compression_steps}+${ejection_steps}+${free_float_steps}
print "Total steps = ${total_steps}"
##### SETTLING #####
run ${settling_steps}
##### Compression & Release #####
variable punch_frequency equal PI/2/(dt*${compression_steps}/2)
variable disp_upper equal -${upper_punch_stroke}*sin(${punch_frequency}*elapsed*dt)
variable short_release equal round(${compression_steps}*1.0)
run ${short_release} # 189170 upto #
##### EJECTION #####
variable punch_frequency equal PI/2/(dt*${ejection_steps})
variable disp_lower equal ${dieHeight}*sin(${punch_frequency}*elapsed*dt)
variable disp_upper equal 0.9*v_disp_lower
run ${ejection_steps}
##### FREE FLOAT #####
variable disp_lower equal ${dieHeight}
variable disp_upper equal ${dieHeight}*0.9
variable max_disp equal ${dieRadius}*0.75
#variable disp_xPlanePos equal -${max_disp}*elapsed/${free_float_steps}
#variable disp_xPlaneNeg equal -v_disp_xPlanePos
run ${free_float_steps}

View File

@ -0,0 +1,100 @@
############################### SIMULATION SETTINGS ###################################################
atom_style sphere
atom_modify map array
comm_modify vel yes
units si
newton off
neighbor 2 bin
neigh_modify delay 0
timestep 1e-6
######################### SIMULATION BOUNDING BOX, INTEGRATION, AND, GRAVITY ###########################
boundary f f f
read_data spheres.data
fix integr all nve/sphere
########################### PARTICLE MATERIAL PROPERTIES AND FORCE MODEL ###############################
variable atomRadius equal 0.5
pair_style granular
# mdr = E, nu, Y, gamma, psi_b, CoR
# linear_history = k_t, x_gamma,t, mu_s
variable YoungsModulus equal 1e9
variable PoissonsRatio equal 0.3
variable YieldStress equal 50e6
variable SurfaceEnergy equal 0.0
variable psi_b equal 0.5
variable CoR equal 0.5
variable kt equal 2/7*${YoungsModulus}*${atomRadius}
variable xgammat equal 0.0
variable mu_s equal 0.5
pair_coeff * * mdr ${YoungsModulus} ${PoissonsRatio} ${YieldStress} ${SurfaceEnergy} ${psi_b} ${CoR} tangential linear_history ${kt} ${xgammat} ${mu_s} damping none
######################################### ADD IN PLANES ################################################
variable boxWidth equal 3
variable halfBoxWidth equal ${boxWidth}/2
variable plane_disp equal 0.0
variable plane_disp_neg equal 0.0
region plane_yz_pos plane ${halfBoxWidth} 0 0 -1 0 0 side in move v_plane_disp_neg NULL NULL units box
region plane_yz_neg plane -${halfBoxWidth} 0 0 1 0 0 side in move v_plane_disp NULL NULL units box
region plane_xz_pos plane 0 ${halfBoxWidth} 0 0 -1 0 side in move NULL v_plane_disp_neg NULL units box
region plane_xz_neg plane 0 -${halfBoxWidth} 0 0 1 0 side in move NULL v_plane_disp NULL units box
region plane_xy_pos plane 0 0 ${halfBoxWidth} 0 0 -1 side in move NULL NULL v_plane_disp_neg units box
region plane_xy_neg plane 0 0 -${halfBoxWidth} 0 0 1 side in move NULL NULL v_plane_disp units box
variable wall_contact_string string "granular mdr ${YoungsModulus} ${PoissonsRatio} ${YieldStress} ${SurfaceEnergy} ${psi_b} ${CoR} tangential linear_history ${kt} ${xgammat} ${mu_s} damping none"
fix plane_yz_pos all wall/gran/region ${wall_contact_string} region plane_yz_pos contacts
fix plane_yz_neg all wall/gran/region ${wall_contact_string} region plane_yz_neg contacts
fix plane_xz_pos all wall/gran/region ${wall_contact_string} region plane_xz_pos contacts
fix plane_xz_neg all wall/gran/region ${wall_contact_string} region plane_xz_neg contacts
fix plane_xy_pos all wall/gran/region ${wall_contact_string} region plane_xy_pos contacts
fix plane_xy_neg all wall/gran/region ${wall_contact_string} region plane_xy_neg contacts
compute plane_xy_neg_force all reduce sum f_plane_xy_neg[4]
variable plane_xy_neg_force equal c_plane_xy_neg_force
compute plane_xz_neg_force all reduce sum f_plane_xz_neg[3]
variable plane_xz_neg_force equal c_plane_xz_neg_force
compute plane_yz_neg_force all reduce sum f_plane_yz_neg[2]
variable plane_yz_neg_force equal c_plane_yz_neg_force
fix print1 all print 1 "${plane_disp} ${plane_xy_neg_force} ${plane_xz_neg_force} ${plane_yz_neg_force}" file lammps_macro_force_disp_diff_radii.csv screen no
######################################## SCREEN OUTPUT ####################################################
compute 1 all erotate/sphere
thermo_style custom dt step atoms ke c_1 vol
thermo 100
thermo_modify lost ignore norm no
##################################### DEFINE WALL MOVEMENT #################################################
variable disp_max equal 0.499
variable ddisp equal 0.00001
variable compression_steps equal round(${disp_max}/${ddisp})
variable output_rate equal round(${compression_steps}/100)
##################################### SET UP DUMP OUTPUTS ####################################################
#dump dmp all vtk ${output_rate} post/triaxial12particles_*.vtk id type mass x y z vx vy vz fx fy fz radius
dump dumpParticles all custom ${output_rate} triaxial12particles.dump id type mass x y z vx vy vz fx fy fz radius
#################################### COMPRESS THE PARTICLES ##################################################
run 0
variable plane_disp equal ${ddisp}*elapsed
variable plane_disp_neg equal -${ddisp}*elapsed
run ${compression_steps}
#################################### UNCOMPRESS THE PARTICLES ################################################

View File

@ -0,0 +1,164 @@
############################### SIMULATION SETTINGS ###################################################
atom_style sphere 1
atom_modify map array
comm_modify vel yes
units si
newton off
neighbor 2 bin
neigh_modify delay 0
timestep 1e-6
#processors 1 2 1
######################### SIMULATION BOUNDING BOX, INTEGRATION, AND, GRAVITY ###########################
boundary f f f
region box block -100 100 -100 100 -100 100 units box
create_box 2 box
fix integr all nve/sphere
########################### PARTICLE MATERIAL PROPERTIES AND FORCE MODEL ###############################
variable atomRadius equal 0.5
pair_style granular
# mdr = E, nu, Y, gamma, psi_b, CoR
# linear_history = k_t, x_gamma,t, mu_s
variable YoungsModulus equal 1e9
variable PoissonsRatio equal 0.3
variable YieldStress equal 50e6
variable SurfaceEnergy equal 0.0
variable psi_b equal 0.5
variable CoR equal 0.5
variable kt equal 2/7*${YoungsModulus}*${atomRadius}
variable xgammat equal 0.0
variable mu_s equal 0.5
pair_coeff * * mdr ${YoungsModulus} ${PoissonsRatio} ${YieldStress} ${SurfaceEnergy} ${psi_b} ${CoR} tangential linear_history ${kt} ${xgammat} ${mu_s} damping none
######################################### ADD IN PLANES ################################################
variable boxWidth equal 3
variable halfBoxWidth equal ${boxWidth}/2
variable plane_disp equal 0.0
variable plane_disp_neg equal 0.0
region plane_yz_pos plane ${halfBoxWidth} 0 0 -1 0 0 side in move v_plane_disp_neg NULL NULL units box
region plane_yz_neg plane -${halfBoxWidth} 0 0 1 0 0 side in move v_plane_disp NULL NULL units box
region plane_xz_pos plane 0 ${halfBoxWidth} 0 0 -1 0 side in move NULL v_plane_disp_neg NULL units box
region plane_xz_neg plane 0 -${halfBoxWidth} 0 0 1 0 side in move NULL v_plane_disp NULL units box
region plane_xy_pos plane 0 0 ${halfBoxWidth} 0 0 -1 side in move NULL NULL v_plane_disp_neg units box
region plane_xy_neg plane 0 0 -${halfBoxWidth} 0 0 1 side in move NULL NULL v_plane_disp units box
variable wall_contact_string string "granular mdr ${YoungsModulus} ${PoissonsRatio} ${YieldStress} ${SurfaceEnergy} ${psi_b} ${CoR} tangential linear_history ${kt} ${xgammat} ${mu_s} damping none"
fix plane_yz_pos all wall/gran/region ${wall_contact_string} region plane_yz_pos contacts
fix plane_yz_neg all wall/gran/region ${wall_contact_string} region plane_yz_neg contacts
fix plane_xz_pos all wall/gran/region ${wall_contact_string} region plane_xz_pos contacts
fix plane_xz_neg all wall/gran/region ${wall_contact_string} region plane_xz_neg contacts
fix plane_xy_pos all wall/gran/region ${wall_contact_string} region plane_xy_pos contacts
fix plane_xy_neg all wall/gran/region ${wall_contact_string} region plane_xy_neg contacts
compute plane_xy_neg_force all reduce sum f_plane_xy_neg[4]
variable plane_xy_neg_force equal c_plane_xy_neg_force
compute plane_xz_neg_force all reduce sum f_plane_xz_neg[3]
variable plane_xz_neg_force equal c_plane_xz_neg_force
compute plane_yz_neg_force all reduce sum f_plane_yz_neg[2]
variable plane_yz_neg_force equal c_plane_yz_neg_force
fix print1 all print 1 "${plane_disp} ${plane_xy_neg_force} ${plane_xz_neg_force} ${plane_yz_neg_force}" file lammps_macro_force_disp.csv screen no
##################################### INSERT PARTICLES ####################################################
# PARTICLE PROPERTIES
variable d equal 1
variable den equal 1000
create_atoms 1 single -0.1682 0.1113 0.1492 units box
group atomOne id 1
set atom 1 diameter ${d} density ${den}
create_atoms 1 single 0.6234 -0.5134 0.4198 units box
group atomTwo id 2
set atom 2 diameter ${d} density ${den}
create_atoms 1 single 0.8958 0.8304 0.1353 units box
group atomThree id 3
set atom 3 diameter ${d} density ${den}
create_atoms 1 single -0.1058 -0.9321 -0.2803 units box
group atomFour id 4
set atom 4 diameter ${d} density ${den}
create_atoms 1 single -0.7816 0.5089 -0.5358 units box
group atomFive id 5
set atom 5 diameter ${d} density ${den}
create_atoms 1 single 0.09169 -0.1675 -0.9413 units box
group atomSix id 6
set atom 6 diameter ${d} density ${den}
create_atoms 1 single -0.8324 -0.6242 -0.9531 units box
group atomSeven id 7
set atom 7 diameter ${d} density ${den}
create_atoms 1 single -0.8994 -0.6587 0.9025 units box
group atomEight id 8
set atom 8 diameter ${d} density ${den}
create_atoms 1 single -0.08605 0.8565 0.8629 units box
group atomNine id 9
set atom 9 diameter ${d} density ${den}
create_atoms 1 single 0.7989 0.8445 -0.9942 units box
group atomTen id 10
set atom 10 diameter ${d} density ${den}
create_atoms 1 single 0.9317 -0.8971 -0.8523 units box
group atomEleven id 11
set atom 11 diameter ${d} density ${den}
create_atoms 1 single -0.979 0.3867 0.7977 units box
group atomTwelve id 12
set atom 12 diameter ${d} density ${den}
create_atoms 1 single 0.9926 0.2609 0.9693 units box
group atomThirteen id 13
set atom 13 diameter ${d} density ${den}
create_atoms 1 single 0.9814 0.01161 -0.4335 units box
group atomFourteen id 14
set atom 14 diameter ${d} density ${den}
######################################## SCREEN OUTPUT ####################################################
compute 1 all erotate/sphere
thermo_style custom dt step atoms ke c_1 vol
thermo 100
thermo_modify lost ignore norm no
##################################### DEFINE WALL MOVEMENT #################################################
variable disp_max equal 0.45
variable ddisp equal 0.00001
variable compression_steps equal round(${disp_max}/${ddisp})
variable output_rate equal round(${compression_steps}/100)
##################################### SET UP DUMP OUTPUTS ####################################################
#dump dmp all vtk ${output_rate} post/triaxial14particles_*.vtk id type mass x y z vx vy vz fx fy fz radius
dump dumpParticles all custom ${output_rate} triaxial14particles.dump id type mass x y z vx vy vz fx fy fz radius
#################################### COMPRESS THE PARTICLES ##################################################
run 0
variable plane_disp equal ${ddisp}*elapsed
variable plane_disp_neg equal -${ddisp}*elapsed
run ${compression_steps}
#################################### UNCOMPRESS THE PARTICLES ################################################

View File

@ -0,0 +1,23 @@
#LAMMPS data file created by matlab.
12 atoms
1 atom types
-10.0000000000 10.0000000000 xlo xhi
-10.0000000000 10.0000000000 ylo yhi
-10.0000000000 10.0000000000 zlo zhi
Atoms
1 1 0.8000000000 1000.0000000000 0.0717535226 -0.2092222842 0.3662146798
2 1 1.2000000000 1000.0000000000 -0.8233763986 -0.7426114800 -0.8263932264
3 1 0.8000000000 1000.0000000000 -1.0685863278 -0.4494609702 0.2196698078
4 1 0.8000000000 1000.0000000000 0.5829432471 -1.0098803839 -0.7607543861
5 1 0.8000000000 1000.0000000000 -0.8658471132 0.6951192569 0.0107556658
6 1 1.2000000000 1000.0000000000 0.3966456126 0.7215053869 -0.7540113087
7 1 1.2000000000 1000.0000000000 0.7316242921 0.8996483982 0.6751483031
8 1 1.0000000000 1000.0000000000 0.6267527768 -0.8419367233 0.6964197101
9 1 0.8000000000 1000.0000000000 -0.0409043189 -0.1452314035 -1.0102948313
10 1 0.8000000000 1000.0000000000 -0.9495107709 0.6760151650 -0.9220534482
11 1 1.0000000000 1000.0000000000 -0.7488486472 0.2188003421 0.7892021020
12 1 1.2000000000 1000.0000000000 0.8968590780 -0.2350366437 -0.2006719701

View File

@ -0,0 +1,211 @@
#LAMMPS data file created by matlab.
200 atoms
1 atom types
-0.005000 0.005000 xlo xhi
-0.005000 0.005000 ylo yhi
-0.001000 0.020000 zlo zhi
Atoms
1 1 0.001206 1560.000000 -0.000938 0.000556 0.000883
2 1 0.000953 1560.000000 -0.002626 -0.000145 0.002778
3 1 0.001035 1560.000000 -0.000434 0.000172 0.008458
4 1 0.001225 1560.000000 -0.003126 -0.000604 0.004986
5 1 0.001119 1560.000000 0.000772 0.002972 0.002568
6 1 0.001243 1560.000000 -0.000363 0.001184 0.004927
7 1 0.001173 1560.000000 0.000218 0.000243 0.005475
8 1 0.000937 1560.000000 0.000033 0.000029 0.003141
9 1 0.001055 1560.000000 -0.001660 0.001975 0.008611
10 1 0.000938 1560.000000 -0.001818 0.002352 0.002534
11 1 0.000990 1560.000000 0.001592 0.000435 0.004416
12 1 0.000927 1560.000000 -0.001659 -0.000004 0.005901
13 1 0.001272 1560.000000 0.002972 0.000553 0.007291
14 1 0.001226 1560.000000 0.002090 0.000983 0.001406
15 1 0.000957 1560.000000 0.002241 -0.001608 0.001304
16 1 0.001020 1560.000000 -0.001944 0.001290 0.002030
17 1 0.001289 1560.000000 -0.002256 -0.001173 0.003474
18 1 0.000998 1560.000000 0.000771 0.002127 0.000906
19 1 0.000927 1560.000000 0.000186 0.000567 0.001207
20 1 0.001095 1560.000000 -0.000937 -0.003179 0.008173
21 1 0.001006 1560.000000 -0.001736 0.000751 0.004618
22 1 0.001037 1560.000000 0.000784 0.001844 0.002380
23 1 0.001297 1560.000000 0.000234 -0.001597 0.008560
24 1 0.001017 1560.000000 0.002454 -0.000505 0.001171
25 1 0.001110 1560.000000 -0.000803 -0.000415 0.003714
26 1 0.001192 1560.000000 0.002283 0.000648 0.003048
27 1 0.000992 1560.000000 -0.000065 -0.000545 0.007062
28 1 0.001116 1560.000000 0.002174 -0.001463 0.005830
29 1 0.001258 1560.000000 0.001602 0.001853 0.007246
30 1 0.001055 1560.000000 -0.001535 -0.002770 0.007196
31 1 0.000958 1560.000000 -0.000438 -0.000260 0.004709
32 1 0.001188 1560.000000 0.000339 -0.000355 0.009171
33 1 0.001166 1560.000000 0.002513 -0.001215 0.004434
34 1 0.000907 1560.000000 0.001905 -0.000373 0.004921
35 1 0.001245 1560.000000 -0.000091 -0.002620 0.004150
36 1 0.001302 1560.000000 0.003292 0.000184 0.005377
37 1 0.001305 1560.000000 0.002099 0.001261 0.008939
38 1 0.000988 1560.000000 0.003274 0.000136 0.003667
39 1 0.000892 1560.000000 0.001798 -0.002104 0.008610
40 1 0.001247 1560.000000 -0.003058 -0.000575 0.000948
41 1 0.000900 1560.000000 -0.000258 -0.000469 0.001478
42 1 0.000945 1560.000000 -0.001434 -0.001711 0.004610
43 1 0.000977 1560.000000 -0.001410 0.002808 0.004963
44 1 0.000930 1560.000000 -0.002110 -0.001362 0.006749
45 1 0.000931 1560.000000 0.001256 -0.000876 0.000844
46 1 0.000901 1560.000000 0.000899 -0.001189 0.005316
47 1 0.000940 1560.000000 -0.002189 -0.000047 0.007240
48 1 0.001217 1560.000000 -0.000108 -0.001333 0.002257
49 1 0.001088 1560.000000 0.001364 -0.000594 0.002789
50 1 0.001143 1560.000000 -0.000311 -0.001425 0.006092
51 1 0.001054 1560.000000 0.002262 0.002312 0.004315
52 1 0.001016 1560.000000 -0.000724 0.000741 0.003295
53 1 0.001051 1560.000000 0.000527 -0.001987 0.003307
54 1 0.000905 1560.000000 0.000827 0.001457 0.005868
55 1 0.001195 1560.000000 -0.001176 -0.000645 0.000798
56 1 0.001253 1560.000000 0.002583 -0.001847 0.003310
57 1 0.000982 1560.000000 0.001551 -0.002803 0.005076
58 1 0.000945 1560.000000 -0.000481 0.000354 0.007220
59 1 0.001040 1560.000000 -0.002736 0.001076 0.008769
60 1 0.000917 1560.000000 0.000826 -0.001887 0.006449
61 1 0.000914 1560.000000 -0.001171 -0.001592 0.007266
62 1 0.000959 1560.000000 0.000834 -0.002671 0.007105
63 1 0.000990 1560.000000 -0.000251 -0.001327 0.004339
64 1 0.001220 1560.000000 0.001384 0.002896 0.005874
65 1 0.000949 1560.000000 -0.001340 -0.000608 0.007496
66 1 0.001306 1560.000000 0.002187 0.002068 0.002629
67 1 0.001206 1560.000000 0.000148 0.001506 0.008517
68 1 0.001123 1560.000000 0.001288 -0.000303 0.006613
69 1 0.001151 1560.000000 -0.000876 0.001549 0.001740
70 1 0.001315 1560.000000 -0.001902 -0.002590 0.001344
71 1 0.000927 1560.000000 0.002285 -0.000866 0.006900
72 1 0.001279 1560.000000 -0.000165 0.002689 0.007449
73 1 0.000910 1560.000000 0.001009 0.001054 0.005049
74 1 0.001148 1560.000000 -0.002229 -0.001285 0.008736
75 1 0.001067 1560.000000 -0.000261 -0.002945 0.002157
76 1 0.000993 1560.000000 -0.001641 0.002272 0.007601
77 1 0.001228 1560.000000 0.001939 -0.000214 0.008903
78 1 0.001076 1560.000000 0.000767 0.001172 0.003556
79 1 0.001105 1560.000000 -0.000561 0.002493 0.004214
80 1 0.001195 1560.000000 0.002694 -0.000817 0.007949
81 1 0.001239 1560.000000 -0.000968 -0.003145 0.006096
82 1 0.001083 1560.000000 -0.000808 0.001813 0.006396
83 1 0.000923 1560.000000 0.000632 -0.001437 0.001310
84 1 0.000981 1560.000000 -0.001842 0.002774 0.006508
85 1 0.000998 1560.000000 -0.002775 0.001616 0.001453
86 1 0.000979 1560.000000 -0.002520 0.001715 0.007741
87 1 0.001002 1560.000000 -0.001465 -0.001931 0.006048
88 1 0.000958 1560.000000 0.003264 0.000707 0.001189
89 1 0.001052 1560.000000 -0.001314 -0.000701 0.002721
90 1 0.001096 1560.000000 0.001154 0.002129 0.004403
91 1 0.001104 1560.000000 0.002118 0.001977 0.000794
92 1 0.001263 1560.000000 -0.001499 -0.002764 0.003441
93 1 0.001086 1560.000000 -0.001096 0.002514 0.001154
94 1 0.000895 1560.000000 0.001130 0.000029 0.001045
95 1 0.000964 1560.000000 0.000905 -0.003200 0.000542
96 1 0.000898 1560.000000 -0.000868 0.003148 0.008306
97 1 0.000907 1560.000000 -0.001406 0.001144 0.007862
98 1 0.001176 1560.000000 0.001246 -0.001074 0.004327
99 1 0.001148 1560.000000 0.001512 -0.002739 0.003346
100 1 0.000922 1560.000000 0.001470 -0.000036 0.007695
101 1 0.001031 1560.000000 -0.002751 0.000928 0.004124
102 1 0.001030 1560.000000 -0.000177 -0.002370 0.005374
103 1 0.000915 1560.000000 0.000824 0.000521 0.007070
104 1 0.001085 1560.000000 -0.002281 -0.000023 0.009123
105 1 0.001004 1560.000000 -0.000167 0.002610 0.008905
106 1 0.001060 1560.000000 -0.000389 -0.002220 0.007688
107 1 0.000920 1560.000000 -0.000483 0.003231 0.006505
108 1 0.001122 1560.000000 0.001781 -0.001547 0.002237
109 1 0.001172 1560.000000 -0.002650 0.000830 0.005429
110 1 0.001137 1560.000000 -0.000030 -0.003246 0.001024
111 1 0.001315 1560.000000 0.001470 -0.001735 0.007580
112 1 0.001245 1560.000000 0.000481 -0.003067 0.006025
113 1 0.000904 1560.000000 0.000632 -0.000184 0.002010
114 1 0.000883 1560.000000 -0.001828 0.002191 0.003819
115 1 0.000974 1560.000000 0.002167 0.001616 0.006226
116 1 0.001150 1560.000000 0.000871 -0.002731 0.002136
117 1 0.001312 1560.000000 -0.000326 -0.001971 0.001000
118 1 0.000914 1560.000000 0.001020 0.000810 0.002086
119 1 0.001136 1560.000000 -0.000101 -0.003277 0.007246
120 1 0.000991 1560.000000 -0.001944 0.000576 0.003215
121 1 0.001216 1560.000000 -0.000913 -0.001165 0.008857
122 1 0.001045 1560.000000 -0.003110 0.001062 0.002973
123 1 0.000918 1560.000000 0.000348 0.000365 0.004046
124 1 0.001279 1560.000000 -0.000884 0.003087 0.002268
125 1 0.001065 1560.000000 -0.002238 0.001309 0.006452
126 1 0.001012 1560.000000 -0.002059 -0.001354 0.001935
127 1 0.001142 1560.000000 -0.003011 0.000567 0.001739
128 1 0.000921 1560.000000 0.001764 0.002804 0.008177
129 1 0.001151 1560.000000 -0.003105 -0.000384 0.006602
130 1 0.000967 1560.000000 0.000932 0.000588 0.008823
131 1 0.000908 1560.000000 -0.001873 -0.001947 0.007825
132 1 0.000923 1560.000000 -0.002993 0.000883 0.007425
133 1 0.001171 1560.000000 0.003310 -0.000405 0.006558
134 1 0.000977 1560.000000 -0.000098 -0.000180 0.000492
135 1 0.000938 1560.000000 -0.000706 -0.000129 0.006085
136 1 0.001008 1560.000000 -0.000256 0.002333 0.000550
137 1 0.001073 1560.000000 0.000534 -0.000055 0.008080
138 1 0.000890 1560.000000 0.000351 0.001695 0.007195
139 1 0.000973 1560.000000 0.002593 0.001907 0.005394
140 1 0.001176 1560.000000 -0.001862 -0.000534 0.004494
141 1 0.001306 1560.000000 -0.000951 0.001053 0.009299
142 1 0.001103 1560.000000 -0.001937 -0.002711 0.008485
143 1 0.001262 1560.000000 -0.002947 -0.001470 0.007682
144 1 0.000914 1560.000000 0.002047 0.000811 0.005504
145 1 0.000954 1560.000000 0.001935 -0.002349 0.006632
146 1 0.001003 1560.000000 0.000766 -0.002635 0.008483
147 1 0.001137 1560.000000 0.000102 0.003195 0.004922
148 1 0.001006 1560.000000 -0.001982 0.001014 0.000685
149 1 0.001255 1560.000000 -0.000718 0.001939 0.003056
150 1 0.001057 1560.000000 -0.001189 -0.001717 0.003045
151 1 0.001228 1560.000000 0.001581 0.002926 0.003510
152 1 0.001052 1560.000000 -0.002172 0.001949 0.004831
153 1 0.000979 1560.000000 -0.001817 0.000291 0.002048
154 1 0.001286 1560.000000 -0.002647 -0.001839 0.004620
155 1 0.001085 1560.000000 -0.000081 0.000850 0.002139
156 1 0.000990 1560.000000 -0.000081 0.002105 0.005587
157 1 0.001043 1560.000000 0.001636 -0.000112 0.001860
158 1 0.001309 1560.000000 0.003216 -0.000851 0.002791
159 1 0.000913 1560.000000 0.000608 0.003148 0.006565
160 1 0.000919 1560.000000 0.000536 -0.003106 0.003249
161 1 0.000943 1560.000000 0.003145 -0.000528 0.008915
162 1 0.000993 1560.000000 -0.002811 -0.000099 0.008110
163 1 0.001125 1560.000000 0.001415 -0.002271 0.000643
164 1 0.000919 1560.000000 -0.001406 0.000223 0.006781
165 1 0.001040 1560.000000 0.000690 0.003193 0.008329
166 1 0.001055 1560.000000 0.001075 0.002584 0.009093
167 1 0.001176 1560.000000 0.000851 0.003176 0.000591
168 1 0.001003 1560.000000 -0.001462 0.001511 0.005544
169 1 0.001126 1560.000000 -0.000077 0.003324 0.001347
170 1 0.001068 1560.000000 0.003110 0.000810 0.008495
171 1 0.001011 1560.000000 -0.001661 0.000117 0.008201
172 1 0.001066 1560.000000 -0.000359 -0.003279 0.009094
173 1 0.001303 1560.000000 0.003066 0.001188 0.004082
174 1 0.000983 1560.000000 0.000354 0.002261 0.003558
175 1 0.001137 1560.000000 0.002860 -0.001571 0.009180
176 1 0.001070 1560.000000 0.001246 -0.001279 0.009104
177 1 0.000886 1560.000000 0.002271 -0.000316 0.003675
178 1 0.000983 1560.000000 -0.001987 -0.002490 0.005377
179 1 0.000939 1560.000000 0.000601 -0.000861 0.003477
180 1 0.001177 1560.000000 0.001522 0.002902 0.001690
181 1 0.001036 1560.000000 -0.001200 -0.002874 0.004750
182 1 0.000898 1560.000000 -0.001705 -0.001140 0.005503
183 1 0.001315 1560.000000 0.002732 0.001766 0.007885
184 1 0.001318 1560.000000 -0.002909 -0.001610 0.005936
185 1 0.001218 1560.000000 0.003213 0.000884 0.002316
186 1 0.001234 1560.000000 -0.002394 -0.002298 0.002575
187 1 0.001160 1560.000000 -0.003313 -0.000065 0.003625
188 1 0.001022 1560.000000 -0.003096 -0.001048 0.002151
189 1 0.000966 1560.000000 0.001891 -0.002093 0.004404
190 1 0.001048 1560.000000 -0.002367 0.002338 0.000697
191 1 0.000995 1560.000000 -0.001204 -0.001912 0.002030
192 1 0.001136 1560.000000 -0.001152 -0.002402 0.009223
193 1 0.001083 1560.000000 -0.002588 -0.001768 0.000753
194 1 0.000946 1560.000000 -0.001338 -0.000741 0.006527
195 1 0.000943 1560.000000 -0.000073 0.003254 0.003663
196 1 0.001059 1560.000000 0.000087 0.000958 0.006388
197 1 0.001131 1560.000000 0.001030 0.001019 0.000752
198 1 0.001257 1560.000000 -0.001365 0.002946 0.009266
199 1 0.000891 1560.000000 -0.000445 -0.000273 0.002382
200 1 0.001055 1560.000000 0.001781 0.000748 0.006583

File diff suppressed because it is too large Load Diff

View File

@ -0,0 +1,21 @@
#LAMMPS data file created by matlab.
10 atoms
1 atom types
-0.005000 0.005000 xlo xhi
-0.005000 0.005000 ylo yhi
-0.001000 0.020000 zlo zhi
Atoms
1 1 0.000249 1560.000000 0.000469 -0.000120 0.008380
2 1 0.000260 1560.000000 -0.001811 0.000425 0.004090
3 1 0.000225 1560.000000 -0.001371 0.000426 0.002952
4 1 0.000252 1560.000000 0.000928 -0.000089 0.004118
5 1 0.000210 1560.000000 0.000208 0.000384 0.000842
6 1 0.000218 1560.000000 -0.002456 -0.000587 0.003834
7 1 0.000201 1560.000000 -0.000278 0.003459 0.003445
8 1 0.000231 1560.000000 -0.002123 0.003188 0.004799
9 1 0.000268 1560.000000 -0.000338 -0.001557 0.007382
10 1 0.000244 1560.000000 0.002537 0.002151 0.005999