Note
Go to the end to download the full example code.
Production run: Circular disc & central sink particle#
This example demonstrates how to run a smoothed particle hydrodynamics (SPH) simulation of a circular disc orbiting around a central sink.
The simulation models:
A central star with a given mass and accretion radius
A gaseous disc with specified mass, inner/outer radii, and vertical structure
Artificial viscosity for angular momentum transport
Locally isothermal equation of state
Also this simulation feature rolling dumps (see purge_old_dumps function) to save disk space.
This example is the accumulation of 3 files in a single one to showcase the complete workflow.
The actual run script (runscript.py)
Plot generation (make_plots.py)
Animation from the plots (plot_to_gif.py)
On a cluster or laptop, one can run the code as follows:
mpirun <your parameters> ./shamrock --sycl-cfg 0:0 --loglevel 1 --rscript runscript.py
then after the run is done (or while it is running), one can run the following to generate the plots:
python make_plots.py
Runscript (runscript.py)#
The runscript is the actual simulation with on the fly analysis & rolling dumps
45 import glob
46 import json
47 import os # for makedirs
48
49 import numpy as np
50
51 import shamrock
52
53 # If we use the shamrock executable to run this script instead of the python interpreter,
54 # we should not initialize the system as the shamrock executable needs to handle specific MPI logic
55 if not shamrock.sys.is_initialized():
56 shamrock.change_loglevel(1)
57 shamrock.sys.init("0:0")
Setup units
62 si = shamrock.UnitSystem()
63 sicte = shamrock.Constants(si)
64 codeu = shamrock.UnitSystem(
65 unit_time=sicte.year(),
66 unit_length=sicte.au(),
67 unit_mass=sicte.sol_mass(),
68 )
69 ucte = shamrock.Constants(codeu)
70 G = ucte.G()
List parameters
75 # Resolution
76 Npart = 100000
77
78 # Domain decomposition parameters
79 scheduler_split_val = int(1.0e7) # split patches with more than 1e7 particles
80 scheduler_merge_val = scheduler_split_val // 16
81
82 # Dump and plot frequency and duration of the simulation
83 dump_freq_stop = 2
84 plot_freq_stop = 1
85
86 dt_stop = 0.01
87 nstop = 30
88
89 # The list of times at which the simulation will pause for analysis / dumping
90 t_stop = [i * dt_stop for i in range(nstop + 1)]
91
92
93 # Sink parameters
94 center_mass = 1.0
95 center_racc = 0.1
96
97 # Disc parameter
98 disc_mass = 0.01 # sol mass
99 rout = 10.0 # au
100 rin = 1.0 # au
101 H_r_0 = 0.05
102 q = 0.5
103 p = 3.0 / 2.0
104 r0 = 1.0
105
106 # Viscosity parameter
107 alpha_AV = 1.0e-3 / 0.08
108 alpha_u = 1.0
109 beta_AV = 2.0
110
111 # Integrator parameters
112 C_cour = 0.3
113 C_force = 0.25
114
115 sim_folder = f"_to_trash/circular_disc_sink_{Npart}/"
116
117 dump_folder = sim_folder + "dump/"
118 analysis_folder = sim_folder + "analysis/"
119 plot_folder = analysis_folder + "plots/"
120
121 dump_prefix = dump_folder + "dump_"
122
123
124 # Disc profiles
125 def sigma_profile(r):
126 sigma_0 = 1.0 # We do not care as it will be renormalized
127 return sigma_0 * (r / r0) ** (-p)
128
129
130 def kep_profile(r):
131 return (G * center_mass / r) ** 0.5
132
133
134 def omega_k(r):
135 return kep_profile(r) / r
136
137
138 def cs_profile(r):
139 cs_in = (H_r_0 * r0) * omega_k(r0)
140 return ((r / r0) ** (-q)) * cs_in
Create the dump directory if it does not exist
145 if shamrock.sys.world_rank() == 0:
146 os.makedirs(sim_folder, exist_ok=True)
147 os.makedirs(dump_folder, exist_ok=True)
148 os.makedirs(analysis_folder, exist_ok=True)
149 os.makedirs(plot_folder, exist_ok=True)
Utility functions and quantities deduced from the base one
154 # Deduced quantities
155 pmass = disc_mass / Npart
156
157 bsize = rout * 2
158 bmin = (-bsize, -bsize, -bsize)
159 bmax = (bsize, bsize, bsize)
160
161 cs0 = cs_profile(r0)
162
163
164 def rot_profile(r):
165 return ((kep_profile(r) ** 2) - (2 * p + q) * cs_profile(r) ** 2) ** 0.5
166
167
168 def H_profile(r):
169 H = cs_profile(r) / omega_k(r)
170 # fact = (2.**0.5) * 3. # factor taken from phantom, to fasten thermalizing
171 fact = 1.0
172 return fact * H
Start the context The context holds the data of the code We then init the layout of the field (e.g. the list of fields used by the solver)
180 ctx = shamrock.Context()
181 ctx.pdata_layout_new()
Attach a SPH model to the context
186 model = shamrock.get_Model_SPH(context=ctx, vector_type="f64_3", sph_kernel="M4")
Dump handling
191 def get_dump_name(idump):
192 return dump_prefix + f"{idump:07}" + ".sham"
193
194
195 def get_vtk_dump_name(idump):
196 return dump_prefix + f"{idump:07}" + ".vtk"
197
198
199 def get_ph_dump_name(idump):
200 return dump_prefix + f"{idump:07}" + ".phdump"
201
202
203 def get_last_dump():
204 res = glob.glob(dump_prefix + "*.sham")
205
206 num_max = -1
207
208 for f in res:
209 try:
210 dump_num = int(f[len(dump_prefix) : -5])
211 if dump_num > num_max:
212 num_max = dump_num
213 except ValueError:
214 pass
215
216 if num_max == -1:
217 return None
218 else:
219 return num_max
220
221
222 def purge_old_dumps():
223 if shamrock.sys.world_rank() == 0:
224 res = glob.glob(dump_prefix + "*.sham")
225 res.sort()
226
227 # The list of dumps to remove (keep the first and last 3 dumps)
228 to_remove = res[1:-3]
229
230 for f in to_remove:
231 os.remove(f)
232
233
234 idump_last_dump = get_last_dump()
235
236 if shamrock.sys.world_rank() == 0:
237 print("Last dump:", idump_last_dump)
Last dump: None
Load the last dump if it exists, setup otherwise
242 if idump_last_dump is not None:
243 model.load_from_dump(get_dump_name(idump_last_dump))
244 else:
245 # Generate the default config
246 cfg = model.gen_default_config()
247 cfg.set_artif_viscosity_ConstantDisc(alpha_u=alpha_u, alpha_AV=alpha_AV, beta_AV=beta_AV)
248 cfg.set_eos_locally_isothermalLP07(cs0=cs0, q=q, r0=r0)
249
250 cfg.add_kill_sphere(center=(0, 0, 0), radius=bsize) # kill particles outside the simulation box
251
252 cfg.set_units(codeu)
253 cfg.set_particle_mass(pmass)
254 # Set the CFL
255 cfg.set_cfl_cour(C_cour)
256 cfg.set_cfl_force(C_force)
257
258 # Enable this to debug the neighbor counts
259 # cfg.set_show_neigh_stats(True)
260
261 # Standard way to set the smoothing length (e.g. Price et al. 2018)
262 cfg.set_smoothing_length_density_based()
263
264 # Standard density based smoothing lenght but with a neighbor count limit
265 # Use it if you have large slowdowns due to giant particles
266 # I recommend to use it if you have a circumbinary discs as the issue is very likely to happen
267 # cfg.set_smoothing_length_density_based_neigh_lim(500)
268
269 # Set the solver config to be the one stored in cfg
270 model.set_solver_config(cfg)
271
272 # Print the solver config
273 model.get_current_config().print_status()
274
275 # Init the scheduler & fields
276 model.init_scheduler(scheduler_split_val, scheduler_merge_val)
277
278 # Set the simulation box size
279 model.resize_simulation_box(bmin, bmax)
280
281 # Create the setup
282
283 setup = model.get_setup()
284 gen_disc = setup.make_generator_disc_mc(
285 part_mass=pmass,
286 disc_mass=disc_mass,
287 r_in=rin,
288 r_out=rout,
289 sigma_profile=sigma_profile,
290 H_profile=H_profile,
291 rot_profile=rot_profile,
292 cs_profile=cs_profile,
293 random_seed=666,
294 )
295
296 # Print the dot graph of the setup
297 print(gen_disc.get_dot())
298
299 # Apply the setup
300 setup.apply_setup(gen_disc)
301
302 # correct the momentum and barycenter of the disc to 0
303 analysis_momentum = shamrock.model_sph.analysisTotalMomentum(model=model)
304 total_momentum = analysis_momentum.get_total_momentum()
305
306 if shamrock.sys.world_rank() == 0:
307 print(f"disc momentum = {total_momentum}")
308
309 model.apply_momentum_offset((-total_momentum[0], -total_momentum[1], -total_momentum[2]))
310
311 # Correct the barycenter before adding the sink
312 analysis_barycenter = shamrock.model_sph.analysisBarycenter(model=model)
313 barycenter, disc_mass = analysis_barycenter.get_barycenter()
314
315 if shamrock.sys.world_rank() == 0:
316 print(f"disc barycenter = {barycenter}")
317
318 model.apply_position_offset((-barycenter[0], -barycenter[1], -barycenter[2]))
319
320 total_momentum = shamrock.model_sph.analysisTotalMomentum(model=model).get_total_momentum()
321
322 if shamrock.sys.world_rank() == 0:
323 print(f"disc momentum after correction = {total_momentum}")
324
325 barycenter, disc_mass = shamrock.model_sph.analysisBarycenter(model=model).get_barycenter()
326
327 if shamrock.sys.world_rank() == 0:
328 print(f"disc barycenter after correction = {barycenter}")
329
330 if not np.allclose(total_momentum, 0.0):
331 raise RuntimeError("disc momentum is not 0")
332 if not np.allclose(barycenter, 0.0):
333 raise RuntimeError("disc barycenter is not 0")
334
335 # now that the barycenter & momentum are 0, we can add the sink
336 model.add_sink(center_mass, (0, 0, 0), (0, 0, 0), center_racc)
337
338 # Run a single step to init the integrator and smoothing length of the particles
339 # Here the htolerance is the maximum factor of evolution of the smoothing length in each
340 # Smoothing length iterations, increasing it affect the performance negatively but increse the
341 # convergence rate of the smoothing length
342 # this is why we increase it temporely to 1.3 before lowering it back to 1.1 (default value)
343 # Note that both ``change_htolerances`` can be removed and it will work the same but would converge
344 # more slowly at the first timestep
345
346 model.change_htolerances(coarse=1.3, fine=1.1)
347 model.timestep()
348 model.change_htolerances(coarse=1.1, fine=1.1)
----- SPH Solver configuration -----
[
{
"artif_viscosity": {
"alpha_AV": 0.0125,
"alpha_u": 1.0,
"av_type": "constant_disc",
"beta_AV": 2.0
},
"boundary_config": {
"bc_type": "free"
},
"cfl_config": {
"cfl_cour": 0.3,
"cfl_force": 0.25,
"cfl_multiplier_stiffness": 2.0,
"eta_sink": 0.05
},
"combined_dtdiv_divcurlv_compute": false,
"debug_dump_filename": "",
"do_debug_dump": false,
"enable_particle_reordering": false,
"eos_config": {
"Tvec": "f64_3",
"cs0": 0.31415811727277826,
"eos_type": "locally_isothermal_lp07",
"q": 0.5,
"r0": 1.0
},
"epsilon_h": 1e-06,
"ext_force_config": {
"force_list": []
},
"gpart_mass": 1e-07,
"h_iter_per_subcycles": 50,
"h_max_subcycles_count": 100,
"htol_up_coarse_cycle": 1.1,
"htol_up_fine_cycle": 1.1,
"kernel_id": "M4<f64>",
"mhd_config": {
"mhd_type": "none"
},
"particle_killing": [
{
"center": [
0.0,
0.0,
0.0
],
"radius": 20.0,
"type": "sphere"
}
],
"particle_reordering_step_freq": 1000,
"show_neigh_stats": false,
"smoothing_length_config": {
"type": "density_based"
},
"time_state": {
"cfl_multiplier": 0.01,
"dt_sph": 0.0,
"time": 0.0
},
"tree_reduction_level": 3,
"type_id": "sycl::vec<f64,3>",
"unit_sys": {
"unit_current": 1.0,
"unit_length": 149597870700.0,
"unit_lumint": 1.0,
"unit_mass": 1.98847e+30,
"unit_qte": 1.0,
"unit_temperature": 1.0,
"unit_time": 31557600.0
},
"use_two_stage_search": true
}
]
------------------------------------
digraph G {
rankdir=LR;
node_0 [label="GeneratorMCDisc"];
node_2 [label="Simulation"];
node_0 -> node_2;
}
Info: pushing data in scheduler, N = 100000 [DataInserterUtility][rank=0]
Info: reattributing data ... [DataInserterUtility][rank=0]
Info: reattributing data done in 27.52 ms [DataInserterUtility][rank=0]
Info: Compute load ... [DataInserterUtility][rank=0]
Info: run scheduler step ... [DataInserterUtility][rank=0]
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 5.90 us (50.8%)
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 1773.00 ns (0.4%)
patch tree reduce : 1032.00 ns (0.2%)
gen split merge : 711.00 ns (0.1%)
split / merge op : 0/0
apply split merge : 982.00 ns (0.2%)
LB compute : 467.17 us (97.7%)
LB move op cnt : 0
LB apply : 3.02 us (0.6%)
Info: Final load balancing step 0 of 3 [SPH setup][rank=0]
Info: Compute load ... [DataInserterUtility][rank=0]
Info: run scheduler step ... [DataInserterUtility][rank=0]
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.79 us (62.6%)
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 1553.00 ns (0.4%)
patch tree reduce : 351.00 ns (0.1%)
gen split merge : 401.00 ns (0.1%)
split / merge op : 0/0
apply split merge : 271.00 ns (0.1%)
LB compute : 376.55 us (98.0%)
LB move op cnt : 0
LB apply : 1924.00 ns (0.5%)
Info: Final load balancing step 1 of 3 [SPH setup][rank=0]
Info: Compute load ... [DataInserterUtility][rank=0]
Info: run scheduler step ... [DataInserterUtility][rank=0]
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.52 us (66.5%)
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 1754.00 ns (0.4%)
patch tree reduce : 411.00 ns (0.1%)
gen split merge : 410.00 ns (0.1%)
split / merge op : 0/0
apply split merge : 270.00 ns (0.1%)
LB compute : 403.42 us (98.1%)
LB move op cnt : 0
LB apply : 2.02 us (0.5%)
Info: Final load balancing step 2 of 3 [SPH setup][rank=0]
Info: Compute load ... [DataInserterUtility][rank=0]
Info: run scheduler step ... [DataInserterUtility][rank=0]
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.50 us (66.6%)
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 1683.00 ns (0.5%)
patch tree reduce : 471.00 ns (0.1%)
gen split merge : 391.00 ns (0.1%)
split / merge op : 0/0
apply split merge : 230.00 ns (0.1%)
LB compute : 327.25 us (97.8%)
LB move op cnt : 0
LB apply : 1793.00 ns (0.5%)
Info: the setup took : 0.34676392500000003 s [SPH setup][rank=0]
disc momentum = (1.60288854742703e-05, 0.00013766309275351513, 0.0)
disc barycenter = (0.013578565247347756, -0.009662650014606458, 0.000369997836038512)
disc momentum after correction = (-1.8058742435461683e-18, 5.7293308552280875e-18, 0.0)
disc barycenter after correction = (-1.895998549134026e-15, -2.1277467635028025e-16, 1.4653669987499396e-17)
---------------- t = 0, dt = 0 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 5.99 us (1.3%)
patch tree reduce : 1042.00 ns (0.2%)
gen split merge : 1022.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1032.00 ns (0.2%)
LB compute : 447.75 us (95.9%)
LB move op cnt : 0
LB apply : 3.24 us (0.7%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.48 us (73.8%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.2909764157267044 unconverged cnt = 100000
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.3782693404447157 unconverged cnt = 100000
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.49175014257813043 unconverged cnt = 100000
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.6392751853515696 unconverged cnt = 99999
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.8310577409570404 unconverged cnt = 99994
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.9111537095081728 unconverged cnt = 99974
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.9808577320660896 unconverged cnt = 99896
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.9808577320660896 unconverged cnt = 99423
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.9808577320660896 unconverged cnt = 92847
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.9808577320660896 unconverged cnt = 46390
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.9808577320660896 unconverged cnt = 1529
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.9808577320660896 unconverged cnt = 6
Info: conservation infos : [sph::Model][rank=0]
sum v = (-4.206412995699793e-18,1.1630163498921319e-17,0)
sum a = (1.6588293239028218e-17,3.1340219048409113e-18,1.598774687942492e-20)
sum e = 0.05019233353443156
sum de = -2.202161072564076e-05
Info: CFL hydro = 7.455574059655493e-05 sink sink = inf [SPH][rank=0]
Info: cfl dt = 7.455574059655493e-05 cfl multiplier : 0.01 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 3.5639e+04 | 100000 | 2.806e+00 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 0 (tsim/hr) [sph::Model][rank=0]
On the fly analysis
353 def save_rho_integ(ext, arr_rho, iplot):
354 if shamrock.sys.world_rank() == 0:
355 metadata = {"extent": [-ext, ext, -ext, ext], "time": model.get_time()}
356 np.save(plot_folder + f"rho_integ_{iplot:07}.npy", arr_rho)
357
358 with open(plot_folder + f"rho_integ_{iplot:07}.json", "w") as fp:
359 json.dump(metadata, fp)
360
361
362 def save_analysis_data(filename, key, value, ianalysis):
363 """Helper to save analysis data to a JSON file."""
364 if shamrock.sys.world_rank() == 0:
365 filepath = os.path.join(analysis_folder, filename)
366 try:
367 with open(filepath, "r") as fp:
368 data = json.load(fp)
369 except (FileNotFoundError, json.JSONDecodeError):
370 data = {key: []}
371 data[key] = data[key][:ianalysis]
372 data[key].append({"t": model.get_time(), key: value})
373 with open(filepath, "w") as fp:
374 json.dump(data, fp, indent=4)
375
376
377 def analysis(ianalysis):
378
379 ext = rout * 1.5
380 nx = 1024
381 ny = 1024
382
383 arr_rho2 = model.render_cartesian_column_integ(
384 "rho",
385 "f64",
386 center=(0.0, 0.0, 0.0),
387 delta_x=(ext * 2, 0, 0.0),
388 delta_y=(0.0, ext * 2, 0.0),
389 nx=nx,
390 ny=ny,
391 )
392
393 save_rho_integ(ext, arr_rho2, ianalysis)
394
395 barycenter, disc_mass = shamrock.model_sph.analysisBarycenter(model=model).get_barycenter()
396
397 total_momentum = shamrock.model_sph.analysisTotalMomentum(model=model).get_total_momentum()
398
399 potential_energy = shamrock.model_sph.analysisEnergyPotential(
400 model=model
401 ).get_potential_energy()
402
403 kinetic_energy = shamrock.model_sph.analysisEnergyKinetic(model=model).get_kinetic_energy()
404
405 save_analysis_data("barycenter.json", "barycenter", barycenter, ianalysis)
406 save_analysis_data("disc_mass.json", "disc_mass", disc_mass, ianalysis)
407 save_analysis_data("total_momentum.json", "total_momentum", total_momentum, ianalysis)
408 save_analysis_data("potential_energy.json", "potential_energy", potential_energy, ianalysis)
409 save_analysis_data("kinetic_energy.json", "kinetic_energy", kinetic_energy, ianalysis)
410
411 sinks = model.get_sinks()
412 save_analysis_data("sinks.json", "sinks", sinks, ianalysis)
413
414 sim_time_delta = model.solver_logs_cumulated_step_time()
415 scount = model.solver_logs_step_count()
416
417 save_analysis_data("sim_time_delta.json", "sim_time_delta", sim_time_delta, ianalysis)
418 save_analysis_data("sim_step_count_delta.json", "sim_step_count_delta", scount, ianalysis)
419
420 model.solver_logs_reset_cumulated_step_time()
421 model.solver_logs_reset_step_count()
422
423 part_count = model.get_total_part_count()
424 save_analysis_data("part_count.json", "part_count", part_count, ianalysis)
Evolve the simulation
429 model.solver_logs_reset_cumulated_step_time()
430 model.solver_logs_reset_step_count()
431
432 t_start = model.get_time()
433
434 idump = 0
435 iplot = 0
436 istop = 0
437 for ttarg in t_stop:
438
439 if ttarg >= t_start:
440 model.evolve_until(ttarg)
441
442 if istop % dump_freq_stop == 0:
443 model.do_vtk_dump(get_vtk_dump_name(idump), True)
444 model.dump(get_dump_name(idump))
445
446 # dump = model.make_phantom_dump()
447 # dump.save_dump(get_ph_dump_name(idump))
448
449 purge_old_dumps()
450
451 if istop % plot_freq_stop == 0:
452 analysis(iplot)
453
454 if istop % dump_freq_stop == 0:
455 idump += 1
456
457 if istop % plot_freq_stop == 0:
458 iplot += 1
459
460 istop += 1
Info: iteration since start : 1 [SPH][rank=0]
Info: time since start : 1199.467015527 (s) [SPH][rank=0]
Info: dump to _to_trash/circular_disc_sink_100000/dump/dump_0000000.vtk [VTK Dump][rank=0]
- took 27.79 ms, bandwidth = 192.20 MB/s
Info: Dumping state to _to_trash/circular_disc_sink_100000/dump/dump_0000000.sham [SPH][rank=0]
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 20.58 us (38.6%)
Info: dump to _to_trash/circular_disc_sink_100000/dump/dump_0000000.sham [Shamrock Dump][rank=0]
- took 52.08 ms, bandwidth = 219.85 MB/s
Info: compute_column_integ field_name: rho, center: (0,0,0), delta_x: (30,0,0), delta_y: (0,30,0), nx: 1024, ny: 1024 [sph::CartesianRender][rank=0]
Info: compute_column_integ took 1748.39 ms [sph::CartesianRender][rank=0]
---------------- t = 0, dt = 7.455574059655493e-05 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.03 us (1.4%)
patch tree reduce : 3.31 us (0.6%)
gen split merge : 931.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1362.00 ns (0.3%)
LB compute : 487.23 us (95.5%)
LB move op cnt : 0
LB apply : 3.60 us (0.7%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.62 us (72.7%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.9656721715191715e-08,7.594663039201449e-10,2.2086040798203267e-11)
sum a = (-3.2526065174565133e-18,-7.382739168268482e-18,1.0577323928838075e-19)
sum e = 0.050192333513713126
sum de = -2.1661253698690333e-05
Info: CFL hydro = 0.0025347941335260634 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.0025347941335260634 cfl multiplier : 0.34 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.8396e+05 | 100000 | 5.436e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 0.49375059027809726 (tsim/hr) [sph::Model][rank=0]
---------------- t = 7.455574059655493e-05, dt = 0.0025347941335260634 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.71 us (1.6%)
patch tree reduce : 1253.00 ns (0.3%)
gen split merge : 761.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 972.00 ns (0.2%)
LB compute : 404.61 us (95.4%)
LB move op cnt : 0
LB apply : 3.36 us (0.8%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.81 us (70.0%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-6.682609976863798e-07,2.564694026860301e-08,7.508012556654175e-10)
sum a = (2.2768245622195593e-18,5.2753211954997825e-18,-1.1921988732604277e-19)
sum e = 0.050194150852476735
sum de = -9.471713797269092e-06
Info: CFL hydro = 0.004171090667846056 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.004171090667846056 cfl multiplier : 0.56 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.8509e+05 | 100000 | 5.403e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 16.88964758143837 (tsim/hr) [sph::Model][rank=0]
---------------- t = 0.0026093498741226184, dt = 0.004171090667846056 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.40 us (1.7%)
patch tree reduce : 1683.00 ns (0.4%)
gen split merge : 922.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1082.00 ns (0.3%)
LB compute : 404.18 us (94.9%)
LB move op cnt : 0
LB apply : 3.55 us (0.8%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.27 us (70.1%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.0973863790165723e-06,3.254529496634128e-08,1.229356135149791e-09)
sum a = (3.0357660829594124e-18,-8.82608331038981e-19,-4.1081097941833566e-20)
sum e = 0.05019732597389731
sum de = 1.0421130362427978e-05
Info: CFL hydro = 0.00526487317425846 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.00526487317425846 cfl multiplier : 0.7066666666666667 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.8327e+05 | 100000 | 5.456e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 27.519515597422224 (tsim/hr) [sph::Model][rank=0]
---------------- t = 0.006780440541968674, dt = 0.003219559458031326 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.04 us (1.5%)
patch tree reduce : 1513.00 ns (0.3%)
gen split merge : 732.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1002.00 ns (0.2%)
LB compute : 459.07 us (95.7%)
LB move op cnt : 0
LB apply : 3.80 us (0.8%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.61 us (73.1%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-8.442731011988895e-07,1.3075743629568274e-08,9.38383610990052e-10)
sum a = (-7.48099499014998e-18,1.6678078731437174e-18,-7.05154928589205e-20)
sum e = 0.05019535034733227
sum de = 2.6089091400926917e-05
Info: CFL hydro = 0.006002219854682364 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.006002219854682364 cfl multiplier : 0.8044444444444444 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.8182e+05 | 100000 | 5.500e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 21.073147209836023 (tsim/hr) [sph::Model][rank=0]
Info: iteration since start : 5 [SPH][rank=0]
Info: time since start : 1203.5504225470002 (s) [SPH][rank=0]
Info: compute_column_integ field_name: rho, center: (0,0,0), delta_x: (30,0,0), delta_y: (0,30,0), nx: 1024, ny: 1024 [sph::CartesianRender][rank=0]
Info: compute_column_integ took 1737.08 ms [sph::CartesianRender][rank=0]
---------------- t = 0.01, dt = 0.006002219854682364 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.60 us (1.5%)
patch tree reduce : 1683.00 ns (0.3%)
gen split merge : 741.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 992.00 ns (0.2%)
LB compute : 469.76 us (95.7%)
LB move op cnt : 0
LB apply : 3.80 us (0.8%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 3.06 us (73.6%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.5701599983532413e-06,7.3770035159216385e-09,1.7298789811182086e-09)
sum a = (5.637851296924623e-18,1.0191500421363742e-17,-1.513012602032994e-19)
sum e = 0.050203011263200724
sum de = 5.4255442163852666e-05
Info: CFL hydro = 0.006522612817613886 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.006522612817613886 cfl multiplier : 0.8696296296296296 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.8121e+05 | 100000 | 5.518e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 39.15592519625852 (tsim/hr) [sph::Model][rank=0]
---------------- t = 0.016002219854682365, dt = 0.003997780145317636 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 8.39 us (2.0%)
patch tree reduce : 1623.00 ns (0.4%)
gen split merge : 972.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1192.00 ns (0.3%)
LB compute : 396.65 us (94.2%)
LB move op cnt : 0
LB apply : 4.05 us (1.0%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.40 us (71.4%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.0413664409669128e-06,-1.5737553220175466e-08,1.1210808762496675e-09)
sum a = (1.0191500421363742e-17,1.3179832659276913e-18,-1.4484263398048536e-19)
sum e = 0.05019747268778869
sum de = 7.407504234678432e-05
Info: CFL hydro = 0.006884931513725254 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.006884931513725254 cfl multiplier : 0.9130864197530864 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.8295e+05 | 100000 | 5.466e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 26.330624026443246 (tsim/hr) [sph::Model][rank=0]
Info: iteration since start : 7 [SPH][rank=0]
Info: time since start : 1206.433514061 (s) [SPH][rank=0]
Info: dump to _to_trash/circular_disc_sink_100000/dump/dump_0000001.vtk [VTK Dump][rank=0]
- took 8.72 ms, bandwidth = 612.46 MB/s
Info: Dumping state to _to_trash/circular_disc_sink_100000/dump/dump_0000001.sham [SPH][rank=0]
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.19 us (52.2%)
Info: dump to _to_trash/circular_disc_sink_100000/dump/dump_0000001.sham [Shamrock Dump][rank=0]
- took 12.82 ms, bandwidth = 893.22 MB/s
Info: compute_column_integ field_name: rho, center: (0,0,0), delta_x: (30,0,0), delta_y: (0,30,0), nx: 1024, ny: 1024 [sph::CartesianRender][rank=0]
Info: compute_column_integ took 1742.62 ms [sph::CartesianRender][rank=0]
---------------- t = 0.02, dt = 0.006884931513725254 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 8.26 us (1.8%)
patch tree reduce : 2.11 us (0.5%)
gen split merge : 1192.00 ns (0.3%)
split / merge op : 0/0
apply split merge : 1022.00 ns (0.2%)
LB compute : 438.37 us (94.9%)
LB move op cnt : 0
LB apply : 3.89 us (0.8%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.50 us (72.6%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.7887410290404424e-06,-5.0267507977692725e-08,1.886472608322153e-09)
sum a = (1.1926223897340549e-18,4.37069000783219e-19,-5.082197683525802e-21)
sum e = 0.050207176404820315
sum de = 0.00010613033736691471
Info: CFL hydro = 0.006885243909396177 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.006885243909396177 cfl multiplier : 0.9420576131687243 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.8238e+05 | 100000 | 5.483e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 45.2040973889689 (tsim/hr) [sph::Model][rank=0]
---------------- t = 0.026884931513725254, dt = 0.0031150684862747448 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.24 us (1.3%)
patch tree reduce : 1252.00 ns (0.3%)
gen split merge : 862.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1012.00 ns (0.2%)
LB compute : 460.49 us (95.8%)
LB move op cnt : 0
LB apply : 3.97 us (0.8%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.71 us (69.7%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-8.060374020519031e-07,-4.0430596282851714e-08,8.117944107784859e-10)
sum a = (-3.686287386450715e-18,-1.0706496453294356e-17,-2.202285662861181e-19)
sum e = 0.05019663840978835
sum de = 0.00012229864803334537
Info: CFL hydro = 0.006938553814328231 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.006938553814328231 cfl multiplier : 0.9613717421124829 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.8371e+05 | 100000 | 5.443e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 20.601557300544524 (tsim/hr) [sph::Model][rank=0]
Info: iteration since start : 9 [SPH][rank=0]
Info: time since start : 1209.3248490170001 (s) [SPH][rank=0]
Info: compute_column_integ field_name: rho, center: (0,0,0), delta_x: (30,0,0), delta_y: (0,30,0), nx: 1024, ny: 1024 [sph::CartesianRender][rank=0]
Info: compute_column_integ took 1745.75 ms [sph::CartesianRender][rank=0]
---------------- t = 0.03, dt = 0.006938553814328231 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.05 us (1.5%)
patch tree reduce : 1373.00 ns (0.3%)
gen split merge : 721.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1242.00 ns (0.3%)
LB compute : 453.28 us (95.6%)
LB move op cnt : 0
LB apply : 3.60 us (0.8%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.73 us (69.8%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.7924496598473063e-06,-1.0758259154199234e-07,1.7593699984390224e-09)
sum a = (-6.288372600415926e-18,-4.743384504624082e-19,1.691418916548431e-19)
sum e = 0.05020870827424666
sum de = 0.00015451841845925198
Info: CFL hydro = 0.006894148307528966 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.006894148307528966 cfl multiplier : 0.9742478280749886 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.7975e+05 | 100000 | 5.563e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 44.89910165461581 (tsim/hr) [sph::Model][rank=0]
---------------- t = 0.03693855381432823, dt = 0.003061446185671772 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.81 us (1.7%)
patch tree reduce : 1402.00 ns (0.3%)
gen split merge : 832.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1022.00 ns (0.2%)
LB compute : 389.95 us (95.0%)
LB move op cnt : 0
LB apply : 3.53 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.76 us (70.5%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-7.883786948089096e-07,-6.448315369945838e-08,7.216140428689504e-10)
sum a = (-3.144186300207963e-18,-1.2163393122571753e-17,-1.4039571100740028e-19)
sum e = 0.05019800537591201
sum de = 0.00017058219426381894
Info: CFL hydro = 0.006869162531313004 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.006869162531313004 cfl multiplier : 0.9828318853833258 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.8122e+05 | 100000 | 5.518e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 19.972130200257077 (tsim/hr) [sph::Model][rank=0]
Info: iteration since start : 11 [SPH][rank=0]
Info: time since start : 1212.210520044 (s) [SPH][rank=0]
Info: dump to _to_trash/circular_disc_sink_100000/dump/dump_0000002.vtk [VTK Dump][rank=0]
- took 8.36 ms, bandwidth = 639.14 MB/s
Info: Dumping state to _to_trash/circular_disc_sink_100000/dump/dump_0000002.sham [SPH][rank=0]
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.13 us (53.8%)
Info: dump to _to_trash/circular_disc_sink_100000/dump/dump_0000002.sham [Shamrock Dump][rank=0]
- took 12.63 ms, bandwidth = 906.77 MB/s
Info: compute_column_integ field_name: rho, center: (0,0,0), delta_x: (30,0,0), delta_y: (0,30,0), nx: 1024, ny: 1024 [sph::CartesianRender][rank=0]
Info: compute_column_integ took 1742.63 ms [sph::CartesianRender][rank=0]
---------------- t = 0.04, dt = 0.006869162531313004 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.14 us (1.6%)
patch tree reduce : 1252.00 ns (0.3%)
gen split merge : 1122.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1012.00 ns (0.2%)
LB compute : 431.42 us (95.4%)
LB move op cnt : 0
LB apply : 3.55 us (0.8%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.54 us (69.6%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.7668618677718357e-06,-1.6135602256501024e-07,1.55842452836728e-09)
sum a = (-9.540979117872439e-18,-1.0028870095490916e-18,1.1376711272809321e-19)
sum e = 0.05021021405962103
sum de = 0.00020251240603565355
Info: CFL hydro = 0.006705855929590406 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.006705855929590406 cfl multiplier : 0.9885545902555505 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.8095e+05 | 100000 | 5.526e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 44.748079574410774 (tsim/hr) [sph::Model][rank=0]
---------------- t = 0.046869162531313006, dt = 0.0031308374686869964 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.31 us (1.4%)
patch tree reduce : 1413.00 ns (0.3%)
gen split merge : 892.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1002.00 ns (0.2%)
LB compute : 487.29 us (95.7%)
LB move op cnt : 0
LB apply : 3.62 us (0.7%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.48 us (72.3%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-8.03596161463273e-07,-9.050234019431596e-08,6.415713028652022e-10)
sum a = (2.3852447794681098e-18,6.478107980600889e-18,1.1006134358385565e-19)
sum e = 0.05020007596447591
sum de = 0.0002189724253573339
Info: CFL hydro = 0.00666588466774017 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.00666588466774017 cfl multiplier : 0.9923697268370336 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.8254e+05 | 100000 | 5.478e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 20.574155425323667 (tsim/hr) [sph::Model][rank=0]
Info: iteration since start : 13 [SPH][rank=0]
Info: time since start : 1215.108659552 (s) [SPH][rank=0]
Info: compute_column_integ field_name: rho, center: (0,0,0), delta_x: (30,0,0), delta_y: (0,30,0), nx: 1024, ny: 1024 [sph::CartesianRender][rank=0]
Info: compute_column_integ took 1743.33 ms [sph::CartesianRender][rank=0]
---------------- t = 0.05, dt = 0.00666588466774017 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.63 us (1.9%)
patch tree reduce : 1643.00 ns (0.4%)
gen split merge : 662.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 972.00 ns (0.2%)
LB compute : 378.61 us (94.7%)
LB move op cnt : 0
LB apply : 3.38 us (0.8%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.93 us (68.4%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.7096908111558174e-06,-2.0909216866580115e-07,1.2927878907042177e-09)
sum a = (7.914675859144182e-18,-1.463672932855431e-18,3.6263598054324733e-20)
sum e = 0.050211647943887903
sum de = 0.00025003651689464317
Info: CFL hydro = 0.006971781370587604 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.006971781370587604 cfl multiplier : 0.9949131512246892 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.8098e+05 | 100000 | 5.525e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 43.430759394697716 (tsim/hr) [sph::Model][rank=0]
---------------- t = 0.056665884667740175, dt = 0.0033341153322598224 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.86 us (1.7%)
patch tree reduce : 1293.00 ns (0.3%)
gen split merge : 1062.00 ns (0.3%)
split / merge op : 0/0
apply split merge : 992.00 ns (0.2%)
LB compute : 379.75 us (95.0%)
LB move op cnt : 0
LB apply : 3.37 us (0.8%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.29 us (70.9%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-8.542434002242572e-07,-1.2208265924935777e-07,5.619935242092157e-10)
sum a = (3.903127820947816e-18,-9.486769009248164e-20,-7.517417406881916e-21)
sum e = 0.05020288719975112
sum de = 0.00026742620474304286
Info: CFL hydro = 0.006922494957653106 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.006922494957653106 cfl multiplier : 0.9966087674831261 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.8137e+05 | 100000 | 5.514e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 21.76894346310197 (tsim/hr) [sph::Model][rank=0]
Info: iteration since start : 15 [SPH][rank=0]
Info: time since start : 1217.9878649050002 (s) [SPH][rank=0]
Info: dump to _to_trash/circular_disc_sink_100000/dump/dump_0000003.vtk [VTK Dump][rank=0]
- took 8.61 ms, bandwidth = 620.00 MB/s
Info: Dumping state to _to_trash/circular_disc_sink_100000/dump/dump_0000003.sham [SPH][rank=0]
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.97 us (54.4%)
Info: dump to _to_trash/circular_disc_sink_100000/dump/dump_0000003.sham [Shamrock Dump][rank=0]
- took 14.06 ms, bandwidth = 814.31 MB/s
Info: compute_column_integ field_name: rho, center: (0,0,0), delta_x: (30,0,0), delta_y: (0,30,0), nx: 1024, ny: 1024 [sph::CartesianRender][rank=0]
Info: compute_column_integ took 1747.03 ms [sph::CartesianRender][rank=0]
---------------- t = 0.06, dt = 0.006922494957653106 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 8.54 us (1.7%)
patch tree reduce : 1984.00 ns (0.4%)
gen split merge : 861.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1533.00 ns (0.3%)
LB compute : 486.21 us (95.1%)
LB move op cnt : 0
LB apply : 4.31 us (0.8%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.81 us (70.5%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.773144352540634e-06,-2.7172169436875156e-07,1.0719261829863284e-09)
sum a = (5.9631119486702744e-18,9.703609443745265e-18,1.2806079371300953e-19)
sum e = 0.05021548996534039
sum de = 0.0002994496582234882
Info: CFL hydro = 0.006751419943399584 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.006751419943399584 cfl multiplier : 0.997739178322084 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.7963e+05 | 100000 | 5.567e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 44.765523755933785 (tsim/hr) [sph::Model][rank=0]
---------------- t = 0.06692249495765311, dt = 0.003077505042346898 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.96 us (1.9%)
patch tree reduce : 1332.00 ns (0.4%)
gen split merge : 661.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 992.00 ns (0.3%)
LB compute : 354.35 us (94.6%)
LB move op cnt : 0
LB apply : 3.26 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 3.03 us (68.0%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-7.882486607098681e-07,-1.377979977074432e-07,3.8238668522477307e-10)
sum a = (7.15573433840433e-18,7.047314121155779e-18,-2.2303436292389796e-19)
sum e = 0.05020532806800749
sum de = 0.0003158184696971342
Info: CFL hydro = 0.006664061971654347 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.006664061971654347 cfl multiplier : 0.998492785548056 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.8124e+05 | 100000 | 5.517e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 20.079968006167313 (tsim/hr) [sph::Model][rank=0]
Info: iteration since start : 17 [SPH][rank=0]
Info: time since start : 1220.903003402 (s) [SPH][rank=0]
Info: compute_column_integ field_name: rho, center: (0,0,0), delta_x: (30,0,0), delta_y: (0,30,0), nx: 1024, ny: 1024 [sph::CartesianRender][rank=0]
Info: compute_column_integ took 1741.40 ms [sph::CartesianRender][rank=0]
---------------- t = 0.07, dt = 0.006664061971654347 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.16 us (1.6%)
patch tree reduce : 1532.00 ns (0.3%)
gen split merge : 761.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 992.00 ns (0.2%)
LB compute : 428.84 us (95.4%)
LB move op cnt : 0
LB apply : 3.28 us (0.7%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.62 us (73.8%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.7072351389617031e-06,-3.149360982702988e-07,7.313495533275324e-10)
sum a = (6.830473686658678e-18,3.0086610286472748e-18,-1.6387440551410542e-19)
sum e = 0.05021764109240863
sum de = 0.0003466151170789416
Info: CFL hydro = 0.006459611148853162 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.006459611148853162 cfl multiplier : 0.9989951903653708 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.7855e+05 | 100000 | 5.601e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 42.83494710675035 (tsim/hr) [sph::Model][rank=0]
---------------- t = 0.07666406197165436, dt = 0.003335938028345642 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.62 us (1.8%)
patch tree reduce : 1222.00 ns (0.3%)
gen split merge : 972.00 ns (0.3%)
split / merge op : 0/0
apply split merge : 952.00 ns (0.3%)
LB compute : 347.91 us (94.6%)
LB move op cnt : 0
LB apply : 3.55 us (1.0%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.81 us (65.7%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-8.553897936223448e-07,-1.758687156780524e-07,2.5508486842105024e-10)
sum a = (1.919037845299343e-17,-1.395910297075087e-18,-1.4267211205314621e-19)
sum e = 0.05020920765394433
sum de = 0.0003640691707519167
Info: CFL hydro = 0.006387073008248916 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.006387073008248916 cfl multiplier : 0.9993301269102473 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.8161e+05 | 100000 | 5.506e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 21.810620261577263 (tsim/hr) [sph::Model][rank=0]
Info: iteration since start : 19 [SPH][rank=0]
Info: time since start : 1223.7869611630001 (s) [SPH][rank=0]
Info: dump to _to_trash/circular_disc_sink_100000/dump/dump_0000004.vtk [VTK Dump][rank=0]
- took 8.36 ms, bandwidth = 638.50 MB/s
Info: Dumping state to _to_trash/circular_disc_sink_100000/dump/dump_0000004.sham [SPH][rank=0]
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 5.73 us (49.7%)
Info: dump to _to_trash/circular_disc_sink_100000/dump/dump_0000004.sham [Shamrock Dump][rank=0]
- took 12.75 ms, bandwidth = 897.88 MB/s
Info: compute_column_integ field_name: rho, center: (0,0,0), delta_x: (30,0,0), delta_y: (0,30,0), nx: 1024, ny: 1024 [sph::CartesianRender][rank=0]
Info: compute_column_integ took 1745.71 ms [sph::CartesianRender][rank=0]
---------------- t = 0.08, dt = 0.006387073008248916 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.99 us (1.6%)
patch tree reduce : 1242.00 ns (0.3%)
gen split merge : 1232.00 ns (0.3%)
split / merge op : 0/0
apply split merge : 962.00 ns (0.2%)
LB compute : 415.84 us (95.3%)
LB move op cnt : 0
LB apply : 3.28 us (0.8%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.83 us (71.6%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.6388550283484029e-06,-3.544903884998079e-07,3.7600000783409807e-10)
sum a = (-3.2526065174565133e-19,-8.402566836762659e-19,1.8070918534078464e-19)
sum e = 0.05022021490665642
sum de = 0.0003935896144810545
Info: CFL hydro = 0.006238836158904816 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.006238836158904816 cfl multiplier : 0.9995534179401648 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.8056e+05 | 100000 | 5.538e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 41.51670773291031 (tsim/hr) [sph::Model][rank=0]
---------------- t = 0.08638707300824892, dt = 0.0036129269917510726 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.71 us (1.6%)
patch tree reduce : 1443.00 ns (0.3%)
gen split merge : 741.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 961.00 ns (0.2%)
LB compute : 393.42 us (95.0%)
LB move op cnt : 0
LB apply : 3.70 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.56 us (72.7%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-9.285909781937181e-07,-2.2017496258743984e-07,8.48277778290699e-11)
sum a = (1.8973538018496328e-17,3.279711571768651e-18,-5.580904874834022e-20)
sum e = 0.05021364851322254
sum de = 0.00041213792950263374
Info: CFL hydro = 0.006176586870503953 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.006176586870503953 cfl multiplier : 0.9997022786267765 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.8174e+05 | 100000 | 5.502e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 23.6376441351348 (tsim/hr) [sph::Model][rank=0]
Info: iteration since start : 21 [SPH][rank=0]
Info: time since start : 1226.695698166 (s) [SPH][rank=0]
Info: compute_column_integ field_name: rho, center: (0,0,0), delta_x: (30,0,0), delta_y: (0,30,0), nx: 1024, ny: 1024 [sph::CartesianRender][rank=0]
Info: compute_column_integ took 1744.00 ms [sph::CartesianRender][rank=0]
---------------- t = 0.09, dt = 0.006176586870503953 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 8.90 us (1.9%)
patch tree reduce : 1703.00 ns (0.4%)
gen split merge : 1252.00 ns (0.3%)
split / merge op : 0/0
apply split merge : 1202.00 ns (0.3%)
LB compute : 440.80 us (94.6%)
LB move op cnt : 0
LB apply : 4.02 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.73 us (69.2%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.5893309402441227e-06,-3.9585702550729413e-07,1.5433772200530654e-11)
sum a = (-1.2034644114589099e-17,-9.947554932554503e-18,2.5477162866633252e-20)
sum e = 0.05022355511195737
sum de = 0.00044060529288061483
Info: CFL hydro = 0.006014238605907065 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.006014238605907065 cfl multiplier : 0.9998015190845176 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.7935e+05 | 100000 | 5.576e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 39.87997274104123 (tsim/hr) [sph::Model][rank=0]
---------------- t = 0.09617658687050396, dt = 0.0038234131294960505 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.35 us (1.7%)
patch tree reduce : 1362.00 ns (0.3%)
gen split merge : 802.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 972.00 ns (0.2%)
LB compute : 410.33 us (95.1%)
LB move op cnt : 0
LB apply : 3.85 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.48 us (71.6%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-9.860639133275591e-07,-2.6616768511927545e-07,-1.3354889595974205e-10)
sum a = (5.421010862427522e-18,2.168404344971009e-19,6.212457272518259e-20)
sum e = 0.05021846723263955
sum de = 0.0004599012962513962
Info: CFL hydro = 0.005883360185893123 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.005883360185893123 cfl multiplier : 0.9998676793896785 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.8112e+05 | 100000 | 5.521e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 24.930359355290562 (tsim/hr) [sph::Model][rank=0]
Info: iteration since start : 23 [SPH][rank=0]
Info: time since start : 1229.582748066 (s) [SPH][rank=0]
Info: dump to _to_trash/circular_disc_sink_100000/dump/dump_0000005.vtk [VTK Dump][rank=0]
- took 8.66 ms, bandwidth = 616.64 MB/s
Info: Dumping state to _to_trash/circular_disc_sink_100000/dump/dump_0000005.sham [SPH][rank=0]
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.15 us (54.7%)
Info: dump to _to_trash/circular_disc_sink_100000/dump/dump_0000005.sham [Shamrock Dump][rank=0]
- took 12.40 ms, bandwidth = 923.50 MB/s
Info: compute_column_integ field_name: rho, center: (0,0,0), delta_x: (30,0,0), delta_y: (0,30,0), nx: 1024, ny: 1024 [sph::CartesianRender][rank=0]
Info: compute_column_integ took 1746.52 ms [sph::CartesianRender][rank=0]
---------------- t = 0.1, dt = 0.005883360185893123 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.98 us (1.6%)
patch tree reduce : 1553.00 ns (0.4%)
gen split merge : 671.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1021.00 ns (0.2%)
LB compute : 419.31 us (95.3%)
LB move op cnt : 0
LB apply : 3.61 us (0.8%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.68 us (73.4%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.5197237100011239e-06,-4.302588342352739e-07,-3.474334837463383e-10)
sum a = (1.0516761073109393e-17,2.927345865710862e-18,1.7996803151193713e-19)
sum e = 0.05022705543216734
sum de = 0.00048692100568994675
Info: CFL hydro = 0.005691229931608789 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.005691229931608789 cfl multiplier : 0.9999117862597856 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.7929e+05 | 100000 | 5.578e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 37.97390319638751 (tsim/hr) [sph::Model][rank=0]
---------------- t = 0.10588336018589313, dt = 0.0041166398141068705 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.75 us (1.7%)
patch tree reduce : 1173.00 ns (0.3%)
gen split merge : 752.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1323.00 ns (0.3%)
LB compute : 382.39 us (94.7%)
LB move op cnt : 0
LB apply : 3.93 us (1.0%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.91 us (71.6%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.066170627511333e-06,-3.239948967519314e-07,-4.0160173643761004e-10)
sum a = (-3.686287386450715e-18,1.1384122811097797e-18,1.214433488125853e-19)
sum e = 0.05022398580047361
sum de = 0.0005071920845869943
Info: CFL hydro = 0.005572064369820597 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.005572064369820597 cfl multiplier : 0.9999411908398571 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.7034e+05 | 100000 | 5.871e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 25.243553170994865 (tsim/hr) [sph::Model][rank=0]
Info: iteration since start : 25 [SPH][rank=0]
Info: time since start : 1232.533700187 (s) [SPH][rank=0]
Info: compute_column_integ field_name: rho, center: (0,0,0), delta_x: (30,0,0), delta_y: (0,30,0), nx: 1024, ny: 1024 [sph::CartesianRender][rank=0]
Info: compute_column_integ took 1751.96 ms [sph::CartesianRender][rank=0]
---------------- t = 0.11, dt = 0.005572064369820597 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.92 us (1.5%)
patch tree reduce : 1332.00 ns (0.3%)
gen split merge : 751.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 882.00 ns (0.2%)
LB compute : 430.68 us (95.5%)
LB move op cnt : 0
LB apply : 3.64 us (0.8%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.50 us (72.4%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.4459482739289005e-06,-4.609545018034145e-07,-6.990409521225363e-10)
sum a = (-8.239936510889834e-18,4.7704895589362195e-18,2.9116757561866574e-21)
sum e = 0.05023098348620285
sum de = 0.0005326671784511344
Info: CFL hydro = 0.005419472066609618 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.005419472066609618 cfl multiplier : 0.999960793893238 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.7997e+05 | 100000 | 5.556e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 36.101891876151576 (tsim/hr) [sph::Model][rank=0]
---------------- t = 0.11557206436982059, dt = 0.004427935630179403 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.68 us (1.8%)
patch tree reduce : 1372.00 ns (0.4%)
gen split merge : 702.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 972.00 ns (0.3%)
LB compute : 348.98 us (94.4%)
LB move op cnt : 0
LB apply : 3.79 us (1.0%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.42 us (72.2%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.152227847136576e-06,-3.9119404419952004e-07,-7.280677581029877e-10)
sum a = (2.8189256484623115e-18,-4.607859233063394e-19,2.293341704691018e-19)
sum e = 0.05023007500990145
sum de = 0.0005538494307258745
Info: CFL hydro = 0.005310668930967019 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.005310668930967019 cfl multiplier : 0.999973862595492 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.7990e+05 | 100000 | 5.559e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 28.676413057767423 (tsim/hr) [sph::Model][rank=0]
Info: iteration since start : 27 [SPH][rank=0]
Info: time since start : 1235.4297866640002 (s) [SPH][rank=0]
Info: dump to _to_trash/circular_disc_sink_100000/dump/dump_0000006.vtk [VTK Dump][rank=0]
- took 7.98 ms, bandwidth = 669.11 MB/s
Info: Dumping state to _to_trash/circular_disc_sink_100000/dump/dump_0000006.sham [SPH][rank=0]
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.83 us (51.8%)
Info: dump to _to_trash/circular_disc_sink_100000/dump/dump_0000006.sham [Shamrock Dump][rank=0]
- took 11.71 ms, bandwidth = 977.47 MB/s
Info: compute_column_integ field_name: rho, center: (0,0,0), delta_x: (30,0,0), delta_y: (0,30,0), nx: 1024, ny: 1024 [sph::CartesianRender][rank=0]
Info: compute_column_integ took 1747.33 ms [sph::CartesianRender][rank=0]
---------------- t = 0.12, dt = 0.005310668930967019 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.63 us (1.7%)
patch tree reduce : 1423.00 ns (0.3%)
gen split merge : 811.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1031.00 ns (0.2%)
LB compute : 426.08 us (95.0%)
LB move op cnt : 0
LB apply : 3.78 us (0.8%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.26 us (68.9%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.385037641325889e-06,-4.93709727754511e-07,-1.042712872233533e-09)
sum a = (8.131516293641283e-18,7.26415455565288e-18,4.6110356066155975e-20)
sum e = 0.05023558807073412
sum de = 0.0005779422171094894
Info: CFL hydro = 0.005584605720958712 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.005584605720958712 cfl multiplier : 0.9999825750636614 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.7989e+05 | 100000 | 5.559e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 34.39178428049838 (tsim/hr) [sph::Model][rank=0]
---------------- t = 0.125310668930967, dt = 0.004689331069032993 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.96 us (1.1%)
patch tree reduce : 1443.00 ns (0.2%)
gen split merge : 912.00 ns (0.1%)
split / merge op : 0/0
apply split merge : 972.00 ns (0.2%)
LB compute : 597.39 us (96.6%)
LB move op cnt : 0
LB apply : 4.23 us (0.7%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.67 us (72.9%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.2262941691734545e-06,-4.6281261683915137e-07,-1.1051791354543423e-09)
sum a = (2.4936649967166602e-18,4.228388472693467e-18,-8.089164646278568e-20)
sum e = 0.05023655161480795
sum de = 0.0005996932004893336
Info: CFL hydro = 0.005380452266791222 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.005380452266791222 cfl multiplier : 0.9999883833757742 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.7865e+05 | 100000 | 5.598e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 30.158794839782214 (tsim/hr) [sph::Model][rank=0]
Info: iteration since start : 29 [SPH][rank=0]
Info: time since start : 1238.35104786 (s) [SPH][rank=0]
Info: compute_column_integ field_name: rho, center: (0,0,0), delta_x: (30,0,0), delta_y: (0,30,0), nx: 1024, ny: 1024 [sph::CartesianRender][rank=0]
Info: compute_column_integ took 1777.28 ms [sph::CartesianRender][rank=0]
---------------- t = 0.13, dt = 0.005380452266791222 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.35 us (1.7%)
patch tree reduce : 1603.00 ns (0.4%)
gen split merge : 822.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 992.00 ns (0.2%)
LB compute : 419.90 us (95.3%)
LB move op cnt : 0
LB apply : 3.32 us (0.8%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.38 us (68.9%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.410322178661518e-06,-5.5920627460555e-07,-1.4598325868979495e-09)
sum a = (-4.336808689942018e-19,-4.2825985813177425e-18,7.242131699024268e-20)
sum e = 0.050241880080470994
sum de = 0.0006236085398492103
Info: CFL hydro = 0.005481338364437082 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.005481338364437082 cfl multiplier : 0.9999922555838495 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.7870e+05 | 100000 | 5.596e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 34.614177052949465 (tsim/hr) [sph::Model][rank=0]
---------------- t = 0.13538045226679124, dt = 0.004619547733208773 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.86 us (1.8%)
patch tree reduce : 1513.00 ns (0.4%)
gen split merge : 792.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1132.00 ns (0.3%)
LB compute : 360.37 us (94.6%)
LB move op cnt : 0
LB apply : 3.85 us (1.0%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.67 us (69.1%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.213992854217166e-06,-5.088921188133345e-07,-1.4468824082181107e-09)
sum a = (6.613633252161577e-18,-2.168404344971009e-18,3.494010907423989e-20)
sum e = 0.05024260246068956
sum de = 0.0006446177522985313
Info: CFL hydro = 0.005362958813274186 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.005362958813274186 cfl multiplier : 0.9999948370558996 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.8025e+05 | 100000 | 5.548e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 29.975711131622365 (tsim/hr) [sph::Model][rank=0]
Info: iteration since start : 31 [SPH][rank=0]
Info: time since start : 1241.2760587280002 (s) [SPH][rank=0]
Info: dump to _to_trash/circular_disc_sink_100000/dump/dump_0000007.vtk [VTK Dump][rank=0]
- took 7.91 ms, bandwidth = 675.41 MB/s
Info: Dumping state to _to_trash/circular_disc_sink_100000/dump/dump_0000007.sham [SPH][rank=0]
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.02 us (53.7%)
Info: dump to _to_trash/circular_disc_sink_100000/dump/dump_0000007.sham [Shamrock Dump][rank=0]
- took 11.46 ms, bandwidth = 999.00 MB/s
Info: compute_column_integ field_name: rho, center: (0,0,0), delta_x: (30,0,0), delta_y: (0,30,0), nx: 1024, ny: 1024 [sph::CartesianRender][rank=0]
Info: compute_column_integ took 1808.54 ms [sph::CartesianRender][rank=0]
---------------- t = 0.14, dt = 0.005362958813274186 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.21 us (1.8%)
patch tree reduce : 1763.00 ns (0.4%)
gen split merge : 782.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1062.00 ns (0.3%)
LB compute : 382.12 us (94.8%)
LB move op cnt : 0
LB apply : 3.00 us (0.7%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.32 us (70.1%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.4122675001728297e-06,-6.20488877833934e-07,-1.8768526328719758e-09)
sum a = (-3.3610267347050637e-18,-3.415236843329339e-18,1.6284208410963924e-19)
sum e = 0.05024829858541135
sum de = 0.0006677615812474582
Info: CFL hydro = 0.005234211548332898 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.005234211548332898 cfl multiplier : 0.9999965580372665 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.7612e+05 | 100000 | 5.678e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 34.00238896282705 (tsim/hr) [sph::Model][rank=0]
---------------- t = 0.1453629588132742, dt = 0.004637041186725782 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.61 us (1.6%)
patch tree reduce : 1263.00 ns (0.3%)
gen split merge : 761.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 961.00 ns (0.2%)
LB compute : 387.64 us (95.1%)
LB move op cnt : 0
LB apply : 3.67 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.36 us (70.7%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.2237453428278334e-06,-5.673838339606344e-07,-1.8246909256245058e-09)
sum a = (-3.2526065174565133e-19,7.968885967768458e-18,9.105604182983729e-21)
sum e = 0.050249333974157734
sum de = 0.000688220000763834
Info: CFL hydro = 0.005130858233566361 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.005130858233566361 cfl multiplier : 0.9999977053581777 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.7942e+05 | 100000 | 5.574e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 29.95114376948596 (tsim/hr) [sph::Model][rank=0]
Info: iteration since start : 33 [SPH][rank=0]
Info: time since start : 1244.266885775 (s) [SPH][rank=0]
Info: compute_column_integ field_name: rho, center: (0,0,0), delta_x: (30,0,0), delta_y: (0,30,0), nx: 1024, ny: 1024 [sph::CartesianRender][rank=0]
Info: compute_column_integ took 1745.59 ms [sph::CartesianRender][rank=0]
---------------- t = 0.15, dt = 0.005130858233566361 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.91 us (1.6%)
patch tree reduce : 1373.00 ns (0.3%)
gen split merge : 821.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1011.00 ns (0.2%)
LB compute : 406.64 us (95.3%)
LB move op cnt : 0
LB apply : 3.53 us (0.8%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.75 us (71.0%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.3562455178752007e-06,-6.583992270546363e-07,-2.215745076985431e-09)
sum a = (-1.1817803680091998e-17,2.0057740190981832e-18,5.3680713032241284e-20)
sum e = 0.050254342618041674
sum de = 0.0007097491179076717
Info: CFL hydro = 0.005023606283621822 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.005023606283621822 cfl multiplier : 0.9999984702387851 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.7958e+05 | 100000 | 5.568e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 33.17078918739181 (tsim/hr) [sph::Model][rank=0]
---------------- t = 0.15513085823356634, dt = 0.00486914176643366 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.52 us (1.5%)
patch tree reduce : 1232.00 ns (0.3%)
gen split merge : 772.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1102.00 ns (0.3%)
LB compute : 412.54 us (95.2%)
LB move op cnt : 0
LB apply : 3.76 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.57 us (73.2%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.288910997357688e-06,-6.580398709243242e-07,-2.312755265373888e-09)
sum a = (7.589415207398531e-19,7.806255641895632e-18,-1.3404296390299303e-19)
sum e = 0.050257094905151733
sum de = 0.0007301738082083947
Info: CFL hydro = 0.0048963929106479575 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.0048963929106479575 cfl multiplier : 0.99999898015919 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.7954e+05 | 100000 | 5.570e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 31.470680065324725 (tsim/hr) [sph::Model][rank=0]
Info: iteration since start : 35 [SPH][rank=0]
Info: time since start : 1247.1594237890001 (s) [SPH][rank=0]
Info: dump to _to_trash/circular_disc_sink_100000/dump/dump_0000008.vtk [VTK Dump][rank=0]
- took 7.67 ms, bandwidth = 695.95 MB/s
Info: Dumping state to _to_trash/circular_disc_sink_100000/dump/dump_0000008.sham [SPH][rank=0]
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.20 us (54.9%)
Info: dump to _to_trash/circular_disc_sink_100000/dump/dump_0000008.sham [Shamrock Dump][rank=0]
- took 11.88 ms, bandwidth = 963.54 MB/s
Info: compute_column_integ field_name: rho, center: (0,0,0), delta_x: (30,0,0), delta_y: (0,30,0), nx: 1024, ny: 1024 [sph::CartesianRender][rank=0]
Info: compute_column_integ took 1750.13 ms [sph::CartesianRender][rank=0]
---------------- t = 0.16, dt = 0.0048963929106479575 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.96 us (1.5%)
patch tree reduce : 1272.00 ns (0.3%)
gen split merge : 792.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1082.00 ns (0.2%)
LB compute : 448.31 us (95.7%)
LB move op cnt : 0
LB apply : 3.32 us (0.7%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.73 us (68.9%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.2973704754446044e-06,-6.945195949939911e-07,-2.529271167988591e-09)
sum a = (-5.9631119486702744e-18,-6.396792817664476e-18,1.8804131429045468e-19)
sum e = 0.05026080942395955
sum de = 0.000750118788609399
Info: CFL hydro = 0.00477702162571646 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.00477702162571646 cfl multiplier : 0.9999993201061267 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.7825e+05 | 100000 | 5.610e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 31.420641280791504 (tsim/hr) [sph::Model][rank=0]
---------------- t = 0.16489639291064795, dt = 0.00477702162571646 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.68 us (1.8%)
patch tree reduce : 1282.00 ns (0.3%)
gen split merge : 862.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1092.00 ns (0.3%)
LB compute : 359.81 us (94.5%)
LB move op cnt : 0
LB apply : 3.77 us (1.0%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 3.12 us (70.2%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.2663852435780706e-06,-7.108221122841887e-07,-2.670131450261503e-09)
sum a = (-6.396792817664476e-18,-7.589415207398531e-18,1.5225417226896049e-19)
sum e = 0.05026411193982979
sum de = 0.0007692117492397555
Info: CFL hydro = 0.004669704788462559 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.004669704788462559 cfl multiplier : 0.9999995467374179 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.7973e+05 | 100000 | 5.564e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 30.909010787568796 (tsim/hr) [sph::Model][rank=0]
---------------- t = 0.16967341453636442, dt = 0.0003265854636355925 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.02 us (1.9%)
patch tree reduce : 1633.00 ns (0.5%)
gen split merge : 901.00 ns (0.3%)
split / merge op : 0/0
apply split merge : 1002.00 ns (0.3%)
LB compute : 339.49 us (94.2%)
LB move op cnt : 0
LB apply : 3.36 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.85 us (67.3%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-8.657674629640422e-08,-5.088306255521949e-08,-1.9622617752099946e-10)
sum a = (-1.6263032587282567e-18,8.673617379884035e-19,1.7787691892340307e-20)
sum e = 0.050257691894433756
sum de = 0.0007715928873033977
Info: CFL hydro = 0.004664268905480214 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.004664268905480214 cfl multiplier : 0.9999996978249452 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.8218e+05 | 100000 | 5.489e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 2.1418826909963706 (tsim/hr) [sph::Model][rank=0]
Info: iteration since start : 38 [SPH][rank=0]
Info: time since start : 1250.634246606 (s) [SPH][rank=0]
Info: compute_column_integ field_name: rho, center: (0,0,0), delta_x: (30,0,0), delta_y: (0,30,0), nx: 1024, ny: 1024 [sph::CartesianRender][rank=0]
Info: compute_column_integ took 1748.82 ms [sph::CartesianRender][rank=0]
---------------- t = 0.17, dt = 0.004664268905480214 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.06 us (1.6%)
patch tree reduce : 1352.00 ns (0.3%)
gen split merge : 1052.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 992.00 ns (0.2%)
LB compute : 435.14 us (95.5%)
LB move op cnt : 0
LB apply : 3.51 us (0.8%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.54 us (73.0%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.2364574135660623e-06,-7.289769804952941e-07,-2.8159274522805645e-09)
sum a = (5.854691731421724e-18,1.6805133673525319e-18,1.376428539288238e-20)
sum e = 0.05026769932922788
sum de = 0.0007886697167727012
Info: CFL hydro = 0.004683933310493618 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.004683933310493618 cfl multiplier : 0.9999997985499635 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.7974e+05 | 100000 | 5.564e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 30.18024846765088 (tsim/hr) [sph::Model][rank=0]
---------------- t = 0.17466426890548023, dt = 0.004683933310493618 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.35 us (2.0%)
patch tree reduce : 1163.00 ns (0.3%)
gen split merge : 761.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1272.00 ns (0.4%)
LB compute : 342.20 us (94.3%)
LB move op cnt : 0
LB apply : 3.48 us (1.0%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.21 us (70.8%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.2409331950647426e-06,-7.651070690659007e-07,-3.021700064946439e-09)
sum a = (-9.75781955236954e-19,-6.288372600415926e-18,1.5691285347885914e-19)
sum e = 0.05027150105198463
sum de = 0.0008063238786504014
Info: CFL hydro = 0.0046169424731297365 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.0046169424731297365 cfl multiplier : 0.9999998656999756 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.7723e+05 | 100000 | 5.642e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 29.884337135236496 (tsim/hr) [sph::Model][rank=0]
---------------- t = 0.17934820221597386, dt = 0.0006517977840261313 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.58 us (1.6%)
patch tree reduce : 1272.00 ns (0.3%)
gen split merge : 761.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1292.00 ns (0.3%)
LB compute : 379.14 us (95.0%)
LB move op cnt : 0
LB apply : 3.69 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.77 us (71.2%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.7247537883191837e-07,-1.1122156981567969e-07,-4.4786232066973065e-10)
sum a = (4.7704895589362195e-18,-9.432558900623889e-18,-4.7222086809427244e-20)
sum e = 0.05026569118812656
sum de = 0.0008098498340765647
Info: CFL hydro = 0.004610354056647553 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.004610354056647553 cfl multiplier : 0.9999999104666504 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.8258e+05 | 100000 | 5.477e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 4.284287238221767 (tsim/hr) [sph::Model][rank=0]
Info: iteration since start : 41 [SPH][rank=0]
Info: time since start : 1254.08540738 (s) [SPH][rank=0]
Info: dump to _to_trash/circular_disc_sink_100000/dump/dump_0000009.vtk [VTK Dump][rank=0]
- took 8.41 ms, bandwidth = 635.10 MB/s
Info: Dumping state to _to_trash/circular_disc_sink_100000/dump/dump_0000009.sham [SPH][rank=0]
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.42 us (53.8%)
Info: dump to _to_trash/circular_disc_sink_100000/dump/dump_0000009.sham [Shamrock Dump][rank=0]
- took 12.86 ms, bandwidth = 890.68 MB/s
Info: compute_column_integ field_name: rho, center: (0,0,0), delta_x: (30,0,0), delta_y: (0,30,0), nx: 1024, ny: 1024 [sph::CartesianRender][rank=0]
Info: compute_column_integ took 1750.16 ms [sph::CartesianRender][rank=0]
---------------- t = 0.18, dt = 0.004610354056647553 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 8.31 us (1.7%)
patch tree reduce : 1693.00 ns (0.4%)
gen split merge : 1172.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1543.00 ns (0.3%)
LB compute : 452.39 us (94.8%)
LB move op cnt : 0
LB apply : 4.04 us (0.8%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.46 us (70.5%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.2197007015508216e-06,-7.91453279779186e-07,-3.1949482437200653e-09)
sum a = (-2.168404344971009e-18,-8.673617379884035e-19,-4.5951537388545793e-20)
sum e = 0.05027560724111725
sum de = 0.0008256180852325256
Info: CFL hydro = 0.0047844676176526935 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.0047844676176526935 cfl multiplier : 0.9999999403111003 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.7904e+05 | 100000 | 5.585e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 29.716053907133055 (tsim/hr) [sph::Model][rank=0]
---------------- t = 0.18461035405664755, dt = 0.0047844676176526935 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.00 us (1.7%)
patch tree reduce : 1222.00 ns (0.3%)
gen split merge : 1153.00 ns (0.3%)
split / merge op : 0/0
apply split merge : 972.00 ns (0.2%)
LB compute : 383.10 us (94.8%)
LB move op cnt : 0
LB apply : 3.56 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.35 us (72.3%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.2633061001716901e-06,-8.567565496824865e-07,-3.5154712763268007e-09)
sum a = (6.938893903907228e-18,-4.716279450311944e-18,-6.649208635946258e-20)
sum e = 0.05028009343669187
sum de = 0.0008423376945541929
Info: CFL hydro = 0.0050752360064157094 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.0050752360064157094 cfl multiplier : 0.9999999602074002 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.7920e+05 | 100000 | 5.580e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 30.865949781962428 (tsim/hr) [sph::Model][rank=0]
---------------- t = 0.18939482167430025, dt = 0.0006051783256997567 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.67 us (1.7%)
patch tree reduce : 1252.00 ns (0.3%)
gen split merge : 731.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1022.00 ns (0.3%)
LB compute : 361.60 us (94.7%)
LB move op cnt : 0
LB apply : 3.62 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 3.39 us (75.3%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.5934821894903319e-07,-1.1314166177263133e-07,-4.711189775352829e-10)
sum a = (-8.673617379884035e-18,1.5178830414797062e-17,-2.1281702799764296e-19)
sum e = 0.05027394990468914
sum de = 0.0008456370010524978
Info: CFL hydro = 0.005329535976903073 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.005329535976903073 cfl multiplier : 0.9999999734716001 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.8312e+05 | 100000 | 5.461e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 3.98950608443373 (tsim/hr) [sph::Model][rank=0]
Info: iteration since start : 44 [SPH][rank=0]
Info: time since start : 1257.560438554 (s) [SPH][rank=0]
Info: compute_column_integ field_name: rho, center: (0,0,0), delta_x: (30,0,0), delta_y: (0,30,0), nx: 1024, ny: 1024 [sph::CartesianRender][rank=0]
Info: compute_column_integ took 1790.03 ms [sph::CartesianRender][rank=0]
---------------- t = 0.19, dt = 0.005329535976903073 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.95 us (1.5%)
patch tree reduce : 1493.00 ns (0.3%)
gen split merge : 791.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 991.00 ns (0.2%)
LB compute : 454.17 us (95.7%)
LB move op cnt : 0
LB apply : 3.80 us (0.8%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 8.63 us (68.3%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.4027308370500555e-06,-1.001780931793142e-06,-4.178527604998066e-09)
sum a = (3.577867169202165e-18,-3.5236570605778894e-18,-7.348010817431055e-20)
sum e = 0.050286799700299464
sum de = 0.0008619124758726686
Info: CFL hydro = 0.005274436349765292 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.005274436349765292 cfl multiplier : 0.9999999823144 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.7886e+05 | 100000 | 5.591e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 34.31662828317922 (tsim/hr) [sph::Model][rank=0]
---------------- t = 0.19532953597690308, dt = 0.004670464023096926 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.40 us (1.8%)
patch tree reduce : 1142.00 ns (0.3%)
gen split merge : 792.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 972.00 ns (0.3%)
LB compute : 342.10 us (94.5%)
LB move op cnt : 0
LB apply : 3.78 us (1.0%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.23 us (69.7%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.2240463117621378e-06,-9.201739851041741e-07,-3.891208637031879e-09)
sum a = (-6.5052130349130266e-18,6.613633252161577e-18,-1.7914746834428452e-19)
sum e = 0.050288926152782645
sum de = 0.0008773093563047649
Info: CFL hydro = 0.005212399072079461 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.005212399072079461 cfl multiplier : 0.9999999882095999 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.7671e+05 | 100000 | 5.659e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 29.712079576037766 (tsim/hr) [sph::Model][rank=0]
Info: iteration since start : 46 [SPH][rank=0]
Info: time since start : 1260.5090411410001 (s) [SPH][rank=0]
Info: dump to _to_trash/circular_disc_sink_100000/dump/dump_0000010.vtk [VTK Dump][rank=0]
- took 8.32 ms, bandwidth = 641.63 MB/s
Info: Dumping state to _to_trash/circular_disc_sink_100000/dump/dump_0000010.sham [SPH][rank=0]
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.21 us (52.6%)
Info: dump to _to_trash/circular_disc_sink_100000/dump/dump_0000010.sham [Shamrock Dump][rank=0]
- took 12.72 ms, bandwidth = 900.15 MB/s
Info: compute_column_integ field_name: rho, center: (0,0,0), delta_x: (30,0,0), delta_y: (0,30,0), nx: 1024, ny: 1024 [sph::CartesianRender][rank=0]
Info: compute_column_integ took 1758.87 ms [sph::CartesianRender][rank=0]
---------------- t = 0.2, dt = 0.005212399072079461 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.15 us (1.2%)
patch tree reduce : 1262.00 ns (0.2%)
gen split merge : 732.00 ns (0.1%)
split / merge op : 0/0
apply split merge : 1353.00 ns (0.2%)
LB compute : 557.15 us (96.4%)
LB move op cnt : 0
LB apply : 3.40 us (0.6%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.69 us (71.9%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.3596697694832677e-06,-1.0693393686271938e-06,-4.568560817670403e-09)
sum a = (1.5178830414797062e-18,8.294146619514109e-18,-9.592648127654951e-20)
sum e = 0.050295144961323056
sum de = 0.0008927967699263723
Info: CFL hydro = 0.005074125438253892 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.005074125438253892 cfl multiplier : 0.9999999921397332 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.6870e+05 | 100000 | 5.928e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 31.656339351998533 (tsim/hr) [sph::Model][rank=0]
---------------- t = 0.20521239907207947, dt = 0.004787600927920521 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.51 us (1.7%)
patch tree reduce : 1492.00 ns (0.4%)
gen split merge : 751.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 972.00 ns (0.2%)
LB compute : 373.51 us (94.7%)
LB move op cnt : 0
LB apply : 3.80 us (1.0%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.43 us (71.5%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.2408602422686761e-06,-1.0266704383901819e-06,-4.428979602425829e-09)
sum a = (1.6263032587282567e-18,2.710505431213761e-18,1.113848325639405e-19)
sum e = 0.05029820829741343
sum de = 0.000906871377447132
Info: CFL hydro = 0.00523117896747362 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.00523117896747362 cfl multiplier : 0.9999999947598223 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.7685e+05 | 100000 | 5.655e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 30.48017321830096 (tsim/hr) [sph::Model][rank=0]
Info: iteration since start : 48 [SPH][rank=0]
Info: time since start : 1263.486893627 (s) [SPH][rank=0]
Info: compute_column_integ field_name: rho, center: (0,0,0), delta_x: (30,0,0), delta_y: (0,30,0), nx: 1024, ny: 1024 [sph::CartesianRender][rank=0]
Info: compute_column_integ took 1759.39 ms [sph::CartesianRender][rank=0]
---------------- t = 0.21, dt = 0.00523117896747362 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.90 us (1.5%)
patch tree reduce : 1423.00 ns (0.3%)
gen split merge : 1202.00 ns (0.3%)
split / merge op : 0/0
apply split merge : 1222.00 ns (0.3%)
LB compute : 432.58 us (95.2%)
LB move op cnt : 0
LB apply : 4.10 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.85 us (70.1%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.3462468529836213e-06,-1.1674220554490927e-06,-5.073902382074088e-09)
sum a = (1.5178830414797062e-18,1.3552527156068805e-18,1.2451384324638215e-19)
sum e = 0.05030432962691336
sum de = 0.0009206660421615791
Info: CFL hydro = 0.005119881845559189 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.005119881845559189 cfl multiplier : 0.9999999965065482 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.7813e+05 | 100000 | 5.614e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 33.546555306987976 (tsim/hr) [sph::Model][rank=0]
---------------- t = 0.21523117896747362, dt = 0.004768821032526377 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.43 us (1.8%)
patch tree reduce : 1212.00 ns (0.3%)
gen split merge : 802.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 972.00 ns (0.3%)
LB compute : 346.38 us (94.6%)
LB move op cnt : 0
LB apply : 3.33 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.62 us (69.1%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.2160585290601486e-06,-1.11062354604691e-06,-4.8598170669777305e-09)
sum a = (-6.505213034913027e-19,8.944667923005412e-18,4.446922973085077e-20)
sum e = 0.050307389200033824
sum de = 0.0009330095143404949
Info: CFL hydro = 0.004939545204703321 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.004939545204703321 cfl multiplier : 0.9999999976710322 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.7792e+05 | 100000 | 5.620e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 30.545556104475704 (tsim/hr) [sph::Model][rank=0]
Info: iteration since start : 50 [SPH][rank=0]
Info: time since start : 1266.403400328 (s) [SPH][rank=0]
Info: dump to _to_trash/circular_disc_sink_100000/dump/dump_0000011.vtk [VTK Dump][rank=0]
- took 7.83 ms, bandwidth = 681.79 MB/s
Info: Dumping state to _to_trash/circular_disc_sink_100000/dump/dump_0000011.sham [SPH][rank=0]
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 5.78 us (53.1%)
Info: dump to _to_trash/circular_disc_sink_100000/dump/dump_0000011.sham [Shamrock Dump][rank=0]
- took 11.59 ms, bandwidth = 988.31 MB/s
Info: compute_column_integ field_name: rho, center: (0,0,0), delta_x: (30,0,0), delta_y: (0,30,0), nx: 1024, ny: 1024 [sph::CartesianRender][rank=0]
Info: compute_column_integ took 1757.84 ms [sph::CartesianRender][rank=0]
---------------- t = 0.22, dt = 0.004939545204703321 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.61 us (1.5%)
patch tree reduce : 1312.00 ns (0.3%)
gen split merge : 772.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1012.00 ns (0.2%)
LB compute : 397.25 us (90.7%)
LB move op cnt : 0
LB apply : 3.50 us (0.8%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.35 us (71.4%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.2473639447019953e-06,-1.195001212634659e-06,-5.255511699828445e-09)
sum a = (-1.3010426069826053e-18,1.5612511283791264e-17,-2.0286439086740493e-19)
sum e = 0.050312538494862884
sum de = 0.0009444179768960625
Info: CFL hydro = 0.004770150436526054 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.004770150436526054 cfl multiplier : 0.9999999984473549 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.7854e+05 | 100000 | 5.601e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 31.747766893011303 (tsim/hr) [sph::Model][rank=0]
---------------- t = 0.22493954520470333, dt = 0.004770150436526054 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 8.30 us (2.0%)
patch tree reduce : 1723.00 ns (0.4%)
gen split merge : 1152.00 ns (0.3%)
split / merge op : 0/0
apply split merge : 1543.00 ns (0.4%)
LB compute : 394.35 us (94.0%)
LB move op cnt : 0
LB apply : 3.98 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.39 us (71.1%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.1906551397632473e-06,-1.1993826269203006e-06,-5.2972056653021345e-09)
sum a = (-1.5178830414797062e-18,-3.903127820947816e-18,6.310395457044538e-20)
sum e = 0.05031659351316267
sum de = 0.0009547521262365995
Info: CFL hydro = 0.0048744332327628195 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.0048744332327628195 cfl multiplier : 0.9999999989649032 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.7597e+05 | 100000 | 5.683e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 30.21855282303447 (tsim/hr) [sph::Model][rank=0]
---------------- t = 0.2297096956412294, dt = 0.00029030435877061556 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 8.32 us (2.0%)
patch tree reduce : 1643.00 ns (0.4%)
gen split merge : 892.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1303.00 ns (0.3%)
LB compute : 390.76 us (94.1%)
LB move op cnt : 0
LB apply : 4.61 us (1.1%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.60 us (72.8%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-7.153781705355317e-08,-7.569759104961095e-08,-3.3541733262692665e-10)
sum a = (3.2526065174565133e-18,-1.441988889405721e-17,9.317362419797304e-20)
sum e = 0.05031007813191054
sum de = 0.0009567355585144397
Info: CFL hydro = 0.004866810394631659 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.004866810394631659 cfl multiplier : 0.9999999993099354 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.8296e+05 | 100000 | 5.466e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 1.9121255411157665 (tsim/hr) [sph::Model][rank=0]
Info: iteration since start : 53 [SPH][rank=0]
Info: time since start : 1269.896147446 (s) [SPH][rank=0]
Info: compute_column_integ field_name: rho, center: (0,0,0), delta_x: (30,0,0), delta_y: (0,30,0), nx: 1024, ny: 1024 [sph::CartesianRender][rank=0]
Info: compute_column_integ took 1767.71 ms [sph::CartesianRender][rank=0]
---------------- t = 0.23, dt = 0.004866810394631659 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.54 us (1.6%)
patch tree reduce : 1453.00 ns (0.3%)
gen split merge : 761.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1152.00 ns (0.2%)
LB compute : 442.02 us (94.9%)
LB move op cnt : 0
LB apply : 4.75 us (1.0%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.73 us (74.2%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.1982969254060945e-06,-1.2718114850264006e-06,-5.636398901370454e-09)
sum a = (5.583641188300348e-18,1.6046192152785466e-17,1.0206747014414319e-19)
sum e = 0.05032184077557901
sum de = 0.0009646795225051459
Info: CFL hydro = 0.00507244011540438 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.00507244011540438 cfl multiplier : 0.999999999539957 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.7613e+05 | 100000 | 5.678e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 30.859195738409582 (tsim/hr) [sph::Model][rank=0]
---------------- t = 0.23486681039463167, dt = 0.00507244011540438 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 8.04 us (1.8%)
patch tree reduce : 2.39 us (0.5%)
gen split merge : 912.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1053.00 ns (0.2%)
LB compute : 416.88 us (94.2%)
LB move op cnt : 0
LB apply : 4.64 us (1.0%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.36 us (70.7%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.2303955455641167e-06,-1.374410987042993e-06,-6.10659047833524e-09)
sum a = (8.131516293641283e-19,-6.613633252161577e-18,5.971582278142817e-20)
sum e = 0.05032738983814933
sum de = 0.0009731819884931304
Info: CFL hydro = 0.0050609911806464075 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.0050609911806464075 cfl multiplier : 0.9999999996933046 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.7863e+05 | 100000 | 5.598e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 32.62008720713904 (tsim/hr) [sph::Model][rank=0]
---------------- t = 0.23993925051003606, dt = 6.074948996392937e-05 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.53 us (1.6%)
patch tree reduce : 1433.00 ns (0.4%)
gen split merge : 711.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 981.00 ns (0.2%)
LB compute : 387.12 us (94.9%)
LB move op cnt : 0
LB apply : 3.57 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.31 us (70.8%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.4478176871312361e-08,-1.7077048920246217e-08,-7.602393037663254e-11)
sum a = (4.391018798566293e-18,-9.75781955236954e-18,1.147729643529577e-19)
sum e = 0.05031970965282105
sum de = 0.0009749098760456967
Info: CFL hydro = 0.00506044232417697 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.00506044232417697 cfl multiplier : 0.9999999997955363 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.8396e+05 | 100000 | 5.436e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 0.40231681513590173 (tsim/hr) [sph::Model][rank=0]
Info: iteration since start : 56 [SPH][rank=0]
Info: time since start : 1273.371030559 (s) [SPH][rank=0]
Info: dump to _to_trash/circular_disc_sink_100000/dump/dump_0000012.vtk [VTK Dump][rank=0]
- took 8.08 ms, bandwidth = 660.87 MB/s
Info: Dumping state to _to_trash/circular_disc_sink_100000/dump/dump_0000012.sham [SPH][rank=0]
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.08 us (52.0%)
Info: dump to _to_trash/circular_disc_sink_100000/dump/dump_0000012.sham [Shamrock Dump][rank=0]
- took 11.14 ms, bandwidth = 1.00 GB/s
Info: compute_column_integ field_name: rho, center: (0,0,0), delta_x: (30,0,0), delta_y: (0,30,0), nx: 1024, ny: 1024 [sph::CartesianRender][rank=0]
Info: compute_column_integ took 1767.37 ms [sph::CartesianRender][rank=0]
---------------- t = 0.24, dt = 0.00506044232417697 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.89 us (1.7%)
patch tree reduce : 1382.00 ns (0.3%)
gen split merge : 1102.00 ns (0.3%)
split / merge op : 0/0
apply split merge : 1022.00 ns (0.2%)
LB compute : 393.20 us (95.0%)
LB move op cnt : 0
LB apply : 3.52 us (0.8%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.69 us (71.2%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.205763839467398e-06,-1.4231389530909054e-06,-6.335682773947605e-09)
sum a = (-4.87890977618477e-18,-3.903127820947816e-18,2.405573570202213e-19)
sum e = 0.05033237769858582
sum de = 0.0009807546348721615
Info: CFL hydro = 0.005090798589413701 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.005090798589413701 cfl multiplier : 0.9999999998636909 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.7780e+05 | 100000 | 5.624e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 32.390410230999194 (tsim/hr) [sph::Model][rank=0]
---------------- t = 0.24506044232417695, dt = 0.0049395576758230475 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.33 us (2.0%)
patch tree reduce : 1743.00 ns (0.5%)
gen split merge : 801.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1092.00 ns (0.3%)
LB compute : 350.94 us (94.3%)
LB move op cnt : 0
LB apply : 3.22 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.56 us (69.5%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.1537904063952222e-06,-1.4396069527134283e-06,-6.417843672043125e-09)
sum a = (-1.7889335846010823e-18,-4.7704895589362195e-18,-1.6940658945086007e-20)
sum e = 0.05033689407087341
sum de = 0.0009870010980161227
Info: CFL hydro = 0.004880350375284107 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.004880350375284107 cfl multiplier : 0.9999999999091272 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.7771e+05 | 100000 | 5.627e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 31.600543121241063 (tsim/hr) [sph::Model][rank=0]
Info: iteration since start : 58 [SPH][rank=0]
Info: time since start : 1276.322123455 (s) [SPH][rank=0]
Info: compute_column_integ field_name: rho, center: (0,0,0), delta_x: (30,0,0), delta_y: (0,30,0), nx: 1024, ny: 1024 [sph::CartesianRender][rank=0]
Info: compute_column_integ took 1761.62 ms [sph::CartesianRender][rank=0]
---------------- t = 0.25, dt = 0.004880350375284107 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.71 us (1.7%)
patch tree reduce : 1623.00 ns (0.4%)
gen split merge : 812.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1002.00 ns (0.2%)
LB compute : 433.73 us (95.2%)
LB move op cnt : 0
LB apply : 3.43 us (0.8%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.58 us (73.1%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.1153910022386351e-06,-1.4713334369851691e-06,-6.565135970639002e-09)
sum a = (-1.5178830414797062e-18,-2.5045070184415152e-17,1.257843926672636e-19)
sum e = 0.05034156744158103
sum de = 0.000991990453875829
Info: CFL hydro = 0.004696609389715252 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.004696609389715252 cfl multiplier : 0.9999999999394182 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.7759e+05 | 100000 | 5.631e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 31.200905800948796 (tsim/hr) [sph::Model][rank=0]
---------------- t = 0.2548803503752841, dt = 0.004696609389715252 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.84 us (1.8%)
patch tree reduce : 2.01 us (0.5%)
gen split merge : 741.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 992.00 ns (0.3%)
LB compute : 355.25 us (94.3%)
LB move op cnt : 0
LB apply : 3.58 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 3.02 us (68.6%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.0478915829962665e-06,-1.4626995439515273e-06,-6.530094951235274e-09)
sum a = (-7.15573433840433e-18,-1.8431436932253575e-18,1.1096131609031334e-19)
sum e = 0.0503457211048096
sum de = 0.0009958013456381305
Info: CFL hydro = 0.004860834357490386 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.004860834357490386 cfl multiplier : 0.9999999999596122 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.7713e+05 | 100000 | 5.646e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 29.94839311188496 (tsim/hr) [sph::Model][rank=0]
---------------- t = 0.2595769597649994, dt = 0.0004230402350006157 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.26 us (1.8%)
patch tree reduce : 1232.00 ns (0.3%)
gen split merge : 761.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1042.00 ns (0.3%)
LB compute : 384.83 us (94.8%)
LB move op cnt : 0
LB apply : 3.81 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.35 us (70.1%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-9.199001238660099e-08,-1.3581043042492887e-07,-6.064766300091087e-10)
sum a = (2.0057740190981832e-18,1.463672932855431e-17,-1.2281977735187355e-20)
sum e = 0.05033950640286807
sum de = 0.0009975366243009378
Info: CFL hydro = 0.0048526046195324635 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.0048526046195324635 cfl multiplier : 0.9999999999730749 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.8344e+05 | 100000 | 5.451e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 2.7937450592713593 (tsim/hr) [sph::Model][rank=0]
Info: iteration since start : 61 [SPH][rank=0]
Info: time since start : 1279.791626169 (s) [SPH][rank=0]
Info: dump to _to_trash/circular_disc_sink_100000/dump/dump_0000013.vtk [VTK Dump][rank=0]
- took 7.76 ms, bandwidth = 688.61 MB/s
Info: Dumping state to _to_trash/circular_disc_sink_100000/dump/dump_0000013.sham [SPH][rank=0]
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.23 us (52.3%)
Info: dump to _to_trash/circular_disc_sink_100000/dump/dump_0000013.sham [Shamrock Dump][rank=0]
- took 11.43 ms, bandwidth = 1001.94 MB/s
Info: compute_column_integ field_name: rho, center: (0,0,0), delta_x: (30,0,0), delta_y: (0,30,0), nx: 1024, ny: 1024 [sph::CartesianRender][rank=0]
Info: compute_column_integ took 1771.55 ms [sph::CartesianRender][rank=0]
---------------- t = 0.26, dt = 0.0048526046195324635 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.93 us (1.4%)
patch tree reduce : 1282.00 ns (0.3%)
gen split merge : 771.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1032.00 ns (0.2%)
LB compute : 458.31 us (95.7%)
LB move op cnt : 0
LB apply : 3.56 us (0.7%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.43 us (68.4%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.0526170710335964e-06,-1.5620468948924251e-06,-6.975599228025687e-09)
sum a = (-1.214306433183765e-17,5.854691731421724e-18,-7.962109704190423e-20)
sum e = 0.050351454641376754
sum de = 0.0009985025141078015
Info: CFL hydro = 0.004710225489856545 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.004710225489856545 cfl multiplier : 0.9999999999820499 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.7095e+05 | 100000 | 5.850e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 29.864457026764992 (tsim/hr) [sph::Model][rank=0]
---------------- t = 0.2648526046195325, dt = 0.004710225489856545 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.78 us (1.7%)
patch tree reduce : 1553.00 ns (0.4%)
gen split merge : 861.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1022.00 ns (0.3%)
LB compute : 380.55 us (95.0%)
LB move op cnt : 0
LB apply : 3.45 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.87 us (69.2%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-9.917654452087812e-07,-1.5628772663854942e-06,-6.97994760155149e-09)
sum a = (-4.065758146820642e-18,7.15573433840433e-18,2.532628512290358e-19)
sum e = 0.05035576634776342
sum de = 0.0009998872194114986
Info: CFL hydro = 0.0047825148389824355 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.0047825148389824355 cfl multiplier : 0.9999999999880332 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.7093e+05 | 100000 | 5.850e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 28.983590390710933 (tsim/hr) [sph::Model][rank=0]
---------------- t = 0.26956283010938903, dt = 0.0004371698906109889 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 16.36 us (4.2%)
patch tree reduce : 2.50 us (0.6%)
gen split merge : 681.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1413.00 ns (0.4%)
LB compute : 355.64 us (91.4%)
LB move op cnt : 0
LB apply : 3.88 us (1.0%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.22 us (68.9%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-8.914680566126081e-08,-1.4924447439161929e-07,-6.665382303852129e-10)
sum a = (-5.2583805365546965e-18,9.75781955236954e-18,-1.9778219318387913e-19)
sum e = 0.0503495034129331
sum de = 0.0010014421940503543
Info: CFL hydro = 0.004773755617493552 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.004773755617493552 cfl multiplier : 0.999999999992022 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.7431e+05 | 100000 | 5.737e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 2.743322842666573 (tsim/hr) [sph::Model][rank=0]
Info: iteration since start : 64 [SPH][rank=0]
Info: time since start : 1283.366930698 (s) [SPH][rank=0]
Info: compute_column_integ field_name: rho, center: (0,0,0), delta_x: (30,0,0), delta_y: (0,30,0), nx: 1024, ny: 1024 [sph::CartesianRender][rank=0]
Info: compute_column_integ took 1769.57 ms [sph::CartesianRender][rank=0]
---------------- t = 0.27, dt = 0.004773755617493552 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.59 us (1.7%)
patch tree reduce : 1583.00 ns (0.4%)
gen split merge : 781.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1252.00 ns (0.3%)
LB compute : 421.56 us (95.1%)
LB move op cnt : 0
LB apply : 3.58 us (0.8%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.65 us (69.5%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-9.704029261449899e-07,-1.6339353134898013e-06,-7.297274718175496e-09)
sum a = (-4.87890977618477e-19,-7.047314121155779e-18,4.362219678359647e-20)
sum e = 0.05036118124167458
sum de = 0.0009999124902218364
Info: CFL hydro = 0.004632014889167839 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.004632014889167839 cfl multiplier : 0.9999999999946813 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.7128e+05 | 100000 | 5.838e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 29.43561386807586 (tsim/hr) [sph::Model][rank=0]
---------------- t = 0.27477375561749356, dt = 0.004632014889167839 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.79 us (1.8%)
patch tree reduce : 1413.00 ns (0.4%)
gen split merge : 821.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 972.00 ns (0.3%)
LB compute : 349.15 us (94.5%)
LB move op cnt : 0
LB apply : 3.65 us (1.0%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.60 us (66.4%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-9.080339883185196e-07,-1.6301049623105272e-06,-7.280006458329969e-09)
sum a = (-5.041540102057596e-18,-7.697835424647081e-18,1.9693516023662483e-19)
sum e = 0.05036542192450565
sum de = 0.0009988342787694276
Info: CFL hydro = 0.005266954549192401 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.005266954549192401 cfl multiplier : 0.9999999999964541 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.7045e+05 | 100000 | 5.867e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 28.42258580315223 (tsim/hr) [sph::Model][rank=0]
---------------- t = 0.2794057705066614, dt = 0.0005942294933386494 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.49 us (1.6%)
patch tree reduce : 1483.00 ns (0.3%)
gen split merge : 832.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 982.00 ns (0.2%)
LB compute : 436.01 us (95.3%)
LB move op cnt : 0
LB apply : 3.50 us (0.8%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.62 us (73.4%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.120379426440641e-07,-2.1463467396866213e-07,-9.5857559960419e-10)
sum a = (4.174178364069192e-18,3.903127820947816e-18,1.0545560193316039e-19)
sum e = 0.050359559380858836
sum de = 0.001000061414775037
Info: CFL hydro = 0.005298918571711751 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.005298918571711751 cfl multiplier : 0.999999999997636 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.7480e+05 | 100000 | 5.721e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 3.7393200578895627 (tsim/hr) [sph::Model][rank=0]
Info: iteration since start : 67 [SPH][rank=0]
Info: time since start : 1286.9195500960002 (s) [SPH][rank=0]
Info: dump to _to_trash/circular_disc_sink_100000/dump/dump_0000014.vtk [VTK Dump][rank=0]
- took 8.34 ms, bandwidth = 640.70 MB/s
Info: Dumping state to _to_trash/circular_disc_sink_100000/dump/dump_0000014.sham [SPH][rank=0]
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 5.76 us (53.3%)
Info: dump to _to_trash/circular_disc_sink_100000/dump/dump_0000014.sham [Shamrock Dump][rank=0]
- took 12.34 ms, bandwidth = 927.84 MB/s
Info: compute_column_integ field_name: rho, center: (0,0,0), delta_x: (30,0,0), delta_y: (0,30,0), nx: 1024, ny: 1024 [sph::CartesianRender][rank=0]
Info: compute_column_integ took 1779.64 ms [sph::CartesianRender][rank=0]
---------------- t = 0.28, dt = 0.005298918571711751 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.81 us (1.5%)
patch tree reduce : 1422.00 ns (0.3%)
gen split merge : 1062.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 991.00 ns (0.2%)
LB compute : 418.57 us (95.2%)
LB move op cnt : 0
LB apply : 3.63 us (0.8%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 3.04 us (67.0%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-9.938084937098288e-07,-1.9202278405406866e-06,-8.575968615707852e-09)
sum a = (-5.149960319306146e-18,4.7704895589362195e-18,-5.082197683525802e-20)
sum e = 0.05037335109588796
sum de = 0.0009950266538690687
Info: CFL hydro = 0.005096271291965204 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.005096271291965204 cfl multiplier : 0.999999999998424 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.6995e+05 | 100000 | 5.884e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 32.42056161915098 (tsim/hr) [sph::Model][rank=0]
---------------- t = 0.2852989185717118, dt = 0.0047010814282881785 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.20 us (1.8%)
patch tree reduce : 1342.00 ns (0.3%)
gen split merge : 852.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 972.00 ns (0.2%)
LB compute : 362.58 us (88.9%)
LB move op cnt : 0
LB apply : 3.34 us (0.8%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.46 us (71.5%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-8.384247819933201e-07,-1.7527649421103384e-06,-7.829417131649501e-09)
sum a = (2.656295322589486e-18,-3.7947076036992655e-18,-7.707999820014133e-20)
sum e = 0.05037620844824847
sum de = 0.0009915238791205147
Info: CFL hydro = 0.00491751464066449 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.00491751464066449 cfl multiplier : 0.9999999999989493 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.6066e+05 | 100000 | 6.224e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 27.19061436184486 (tsim/hr) [sph::Model][rank=0]
Info: iteration since start : 69 [SPH][rank=0]
Info: time since start : 1289.97133404 (s) [SPH][rank=0]
Info: compute_column_integ field_name: rho, center: (0,0,0), delta_x: (30,0,0), delta_y: (0,30,0), nx: 1024, ny: 1024 [sph::CartesianRender][rank=0]
Info: compute_column_integ took 1783.59 ms [sph::CartesianRender][rank=0]
---------------- t = 0.29, dt = 0.00491751464066449 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.05 us (1.6%)
patch tree reduce : 1322.00 ns (0.3%)
gen split merge : 1001.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1011.00 ns (0.2%)
LB compute : 423.57 us (95.4%)
LB move op cnt : 0
LB apply : 3.32 us (0.7%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.63 us (74.3%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-8.343870711311548e-07,-1.878354528643745e-06,-8.39322269759312e-09)
sum a = (-5.421010862427522e-20,1.734723475976807e-18,3.006966962752766e-19)
sum e = 0.050381731391781794
sum de = 0.0009858304637511395
Info: CFL hydro = 0.004734203756173239 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.004734203756173239 cfl multiplier : 0.9999999999992996 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.7690e+05 | 100000 | 5.653e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 31.317141827283535 (tsim/hr) [sph::Model][rank=0]
---------------- t = 0.29491751464066446, dt = 0.004734203756173239 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.46 us (2.0%)
patch tree reduce : 1403.00 ns (0.4%)
gen split merge : 751.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1012.00 ns (0.3%)
LB compute : 358.96 us (94.4%)
LB move op cnt : 0
LB apply : 3.42 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.31 us (70.2%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-7.57921158893839e-07,-1.8526751150429663e-06,-8.283374730747634e-09)
sum a = (-2.927345865710862e-18,-5.9631119486702744e-18,-2.5792153243893445e-19)
sum e = 0.05038585848288125
sum de = 0.0009793619204762005
Info: CFL hydro = 0.004816805830632994 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.004816805830632994 cfl multiplier : 0.9999999999995332 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.7847e+05 | 100000 | 5.603e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 30.41659115697815 (tsim/hr) [sph::Model][rank=0]
---------------- t = 0.2996517183968377, dt = 0.0003482816031623037 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 100000 min = 100000 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 100000
max = 100000
avg = 100000
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.08 us (1.9%)
patch tree reduce : 1532.00 ns (0.4%)
gen split merge : 811.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1042.00 ns (0.3%)
LB compute : 354.32 us (94.5%)
LB move op cnt : 0
LB apply : 3.58 us (1.0%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.26 us (71.3%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-5.237342537729576e-08,-1.3936420788011568e-07,-6.236343598695861e-10)
sum a = (-1.734723475976807e-18,1.3444106938820255e-17,-7.580944877925988e-20)
sum e = 0.05037931687738128
sum de = 0.0009803791790745813
Info: CFL hydro = 0.004811945960838054 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.004811945960838054 cfl multiplier : 0.9999999999996888 [sph::Model][rank=0]
Info: processing rate infos : [sph::Model][rank=0]
---------------------------------------------------------------------------------------
| rank | rate (N.s^-1) | Nobj | t compute (s) | MPI | alloc | mem (max) |
---------------------------------------------------------------------------------------
| 0 | 1.7474e+05 | 100000 | 5.723e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 2.190871859018391 (tsim/hr) [sph::Model][rank=0]
Info: iteration since start : 72 [SPH][rank=0]
Info: time since start : 1293.488469848 (s) [SPH][rank=0]
Info: dump to _to_trash/circular_disc_sink_100000/dump/dump_0000015.vtk [VTK Dump][rank=0]
- took 7.91 ms, bandwidth = 675.51 MB/s
Info: Dumping state to _to_trash/circular_disc_sink_100000/dump/dump_0000015.sham [SPH][rank=0]
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.04 us (52.9%)
Info: dump to _to_trash/circular_disc_sink_100000/dump/dump_0000015.sham [Shamrock Dump][rank=0]
- took 11.37 ms, bandwidth = 1007.14 MB/s
Info: compute_column_integ field_name: rho, center: (0,0,0), delta_x: (30,0,0), delta_y: (0,30,0), nx: 1024, ny: 1024 [sph::CartesianRender][rank=0]
Info: compute_column_integ took 1767.40 ms [sph::CartesianRender][rank=0]
Plot generation (make_plots.py)#
Load the on-the-fly analysis after the run to make the plots (everything in this section can be in another file)
468 import matplotlib
469 import matplotlib.pyplot as plt
470
471 # Uncomment this and replace by you dump folder, here since it is just above i comment it out
472 # dump_folder = "my_masterpiece"
473 # dump_folder += "/"
474
475
476 def plot_rho_integ(metadata, arr_rho, iplot):
477
478 ext = metadata["extent"]
479
480 dpi = 200
481
482 # Reset the figure using the same memory as the last one
483 plt.figure(num=1, clear=True, dpi=dpi)
484 import copy
485
486 my_cmap = matplotlib.colormaps["gist_heat"].copy() # copy the default cmap
487 my_cmap.set_bad(color="black")
488
489 res = plt.imshow(
490 arr_rho, cmap=my_cmap, origin="lower", extent=ext, norm="log", vmin=1e-8, vmax=1e-4
491 )
492
493 plt.xlabel("x")
494 plt.ylabel("y")
495 plt.title(f"t = {metadata['time']:0.3f} [years]")
496
497 cbar = plt.colorbar(res, extend="both")
498 cbar.set_label(r"$\int \rho \, \mathrm{d}z$ [code unit]")
499
500 plt.savefig(plot_folder + "rho_integ_{:04}.png".format(iplot))
501 plt.close()
502
503
504 def get_list_dumps_id():
505 import glob
506
507 list_files = glob.glob(plot_folder + "rho_integ_*.npy")
508 list_files.sort()
509 list_dumps_id = []
510 for f in list_files:
511 list_dumps_id.append(int(f.split("_")[-1].split(".")[0]))
512 return list_dumps_id
513
514
515 def load_rho_integ(iplot):
516 with open(plot_folder + f"rho_integ_{iplot:07}.json") as fp:
517 metadata = json.load(fp)
518 return np.load(plot_folder + f"rho_integ_{iplot:07}.npy"), metadata
519
520
521 if shamrock.sys.world_rank() == 0:
522 for iplot in get_list_dumps_id():
523 print("Rendering rho integ plot for dump", iplot)
524 arr_rho, metadata = load_rho_integ(iplot)
525 plot_rho_integ(metadata, arr_rho, iplot)
Rendering rho integ plot for dump 0
Rendering rho integ plot for dump 1
Rendering rho integ plot for dump 2
Rendering rho integ plot for dump 3
Rendering rho integ plot for dump 4
Rendering rho integ plot for dump 5
Rendering rho integ plot for dump 6
Rendering rho integ plot for dump 7
Rendering rho integ plot for dump 8
Rendering rho integ plot for dump 9
Rendering rho integ plot for dump 10
Rendering rho integ plot for dump 11
Rendering rho integ plot for dump 12
Rendering rho integ plot for dump 13
Rendering rho integ plot for dump 14
Rendering rho integ plot for dump 15
Rendering rho integ plot for dump 16
Rendering rho integ plot for dump 17
Rendering rho integ plot for dump 18
Rendering rho integ plot for dump 19
Rendering rho integ plot for dump 20
Rendering rho integ plot for dump 21
Rendering rho integ plot for dump 22
Rendering rho integ plot for dump 23
Rendering rho integ plot for dump 24
Rendering rho integ plot for dump 25
Rendering rho integ plot for dump 26
Rendering rho integ plot for dump 27
Rendering rho integ plot for dump 28
Rendering rho integ plot for dump 29
Rendering rho integ plot for dump 30
Make gif for the doc (plot_to_gif.py)#
Convert PNG sequence to Image sequence in mpl
534 import matplotlib.animation as animation
535
536
537 def show_image_sequence(glob_str, render_gif):
538
539 if render_gif and shamrock.sys.world_rank() == 0:
540
541 import glob
542
543 files = sorted(glob.glob(glob_str))
544
545 from PIL import Image
546
547 image_array = []
548 for my_file in files:
549 image = Image.open(my_file)
550 image_array.append(image)
551
552 if not image_array:
553 raise RuntimeError(f"Warning: No images found for glob pattern: {glob_str}")
554
555 pixel_x, pixel_y = image_array[0].size
556
557 # Create the figure and axes objects
558 # Remove axes, ticks, and frame & set aspect ratio
559 dpi = 200
560 fig = plt.figure(dpi=dpi)
561 plt.gca().set_position((0, 0, 1, 1))
562 plt.gcf().set_size_inches(pixel_x / dpi, pixel_y / dpi)
563 plt.axis("off")
564
565 # Set the initial image with correct aspect ratio
566 im = plt.imshow(image_array[0], animated=True, aspect="auto")
567
568 def update(i):
569 im.set_array(image_array[i])
570 return (im,)
571
572 # Create the animation object
573 ani = animation.FuncAnimation(
574 fig,
575 update,
576 frames=len(image_array),
577 interval=50,
578 blit=True,
579 repeat_delay=10,
580 )
581
582 return ani
Do it for rho integ
588 render_gif = True
589 glob_str = os.path.join(plot_folder, "rho_integ_*.png")
590
591 # If the animation is not returned only a static image will be shown in the doc
592 ani = show_image_sequence(glob_str, render_gif)
593
594 if render_gif and shamrock.sys.world_rank() == 0:
595 # To save the animation using Pillow as a gif
596 writer = animation.PillowWriter(fps=15, metadata=dict(artist="Me"), bitrate=1800)
597 ani.save(analysis_folder + "rho_integ.gif", writer=writer)
598
599 # Show the animation
600 plt.show()