Note
Go to the end to download the full example code.
Production run: Black hole disc & lense thirring effect#
This example demonstrates how to run a smoothed particle hydrodynamics (SPH) simulation of a circular disc orbiting around a central point mass potential.
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.second(),
66 unit_length=sicte.au(),
67 unit_mass=sicte.sol_mass(),
68 )
69 ucte = shamrock.Constants(codeu)
70 G = ucte.G()
71 c = ucte.c()
List parameters
76 # Resolution
77 Npart = 100000
78
79 # Domain decomposition parameters
80 scheduler_split_val = int(1.0e7) # split patches with more than 1e7 particles
81 scheduler_merge_val = scheduler_split_val // 16
82
83 # Disc parameter
84 center_mass = 1e6 # [sol mass]
85 disc_mass = 0.001 # [sol mass]
86 Rg = G * center_mass / (c * c) # [au]
87 rin = 4.0 * Rg # [au]
88 rout = 10 * rin # [au]
89 r0 = rin # [au]
90
91 H_r_0 = 0.01
92 q = 0.75
93 p = 3.0 / 2.0
94
95 Tin = 2 * np.pi * np.sqrt(rin * rin * rin / (G * center_mass))
96 if shamrock.sys.world_rank() == 0:
97 print(" Orbital period : ", Tin, " [seconds]")
98
99 # Sink parameters
100 center_racc = rin / 2.0 # [au]
101 inclination = 30.0 * np.pi / 180.0
102
103
104 # Viscosity parameter
105 alpha_AV = 1.0e-3 / 0.08
106 alpha_u = 1.0
107 beta_AV = 2.0
108
109 # Integrator parameters
110 C_cour = 0.3
111 C_force = 0.25
112
113
114 # Dump and plot frequency and duration of the simulation
115 dump_freq_stop = 1
116 plot_freq_stop = 1
117
118 dt_stop = Tin / 10.0
119 nstop = 10
120
121 # The list of times at which the simulation will pause for analysis / dumping
122 t_stop = [i * dt_stop for i in range(nstop + 1)]
123
124
125 sim_folder = f"_to_trash/black_hole_disc_lense_thirring_{Npart}/"
126
127 dump_folder = sim_folder + "dump/"
128 analysis_folder = sim_folder + "analysis/"
129 plot_folder = analysis_folder + "plots/"
130
131 dump_prefix = dump_folder + "dump_"
132
133
134 # Disc profiles
135 def sigma_profile(r):
136 sigma_0 = 1.0 # We do not care as it will be renormalized
137 return sigma_0 * (r / r0) ** (-p)
138
139
140 def kep_profile(r):
141 return (G * center_mass / r) ** 0.5
142
143
144 def omega_k(r):
145 return kep_profile(r) / r
146
147
148 def cs_profile(r):
149 cs_in = (H_r_0 * r0) * omega_k(r0)
150 return ((r / r0) ** (-q)) * cs_in
Orbital period : 247.58972132551145 [seconds]
Create the dump directory if it does not exist
155 if shamrock.sys.world_rank() == 0:
156 os.makedirs(sim_folder, exist_ok=True)
157 os.makedirs(dump_folder, exist_ok=True)
158 os.makedirs(analysis_folder, exist_ok=True)
159 os.makedirs(plot_folder, exist_ok=True)
Utility functions and quantities deduced from the base one
164 # Deduced quantities
165 pmass = disc_mass / Npart
166
167 bsize = rout * 2
168 bmin = (-bsize, -bsize, -bsize)
169 bmax = (bsize, bsize, bsize)
170
171 cs0 = cs_profile(r0)
172
173
174 def rot_profile(r):
175 return ((kep_profile(r) ** 2) - (2 * p + q) * cs_profile(r) ** 2) ** 0.5
176
177
178 def H_profile(r):
179 H = cs_profile(r) / omega_k(r)
180 # fact = (2.**0.5) * 3. # factor taken from phantom, to fasten thermalizing
181 fact = 1.0
182 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)
190 ctx = shamrock.Context()
191 ctx.pdata_layout_new()
Attach a SPH model to the context
196 model = shamrock.get_Model_SPH(context=ctx, vector_type="f64_3", sph_kernel="M4")
Dump handling
201 def get_dump_name(idump):
202 return dump_prefix + f"{idump:07}" + ".sham"
203
204
205 def get_vtk_dump_name(idump):
206 return dump_prefix + f"{idump:07}" + ".vtk"
207
208
209 def get_ph_dump_name(idump):
210 return dump_prefix + f"{idump:07}" + ".phdump"
211
212
213 def get_last_dump():
214 res = glob.glob(dump_prefix + "*.sham")
215
216 num_max = -1
217
218 for f in res:
219 try:
220 dump_num = int(f[len(dump_prefix) : -5])
221 if dump_num > num_max:
222 num_max = dump_num
223 except ValueError:
224 pass
225
226 if num_max == -1:
227 return None
228 else:
229 return num_max
230
231
232 def purge_old_dumps():
233 if shamrock.sys.world_rank() == 0:
234 res = glob.glob(dump_prefix + "*.sham")
235 res.sort()
236
237 # The list of dumps to remove (keep the first and last 3 dumps)
238 to_remove = res[1:-3]
239
240 for f in to_remove:
241 os.remove(f)
242
243
244 idump_last_dump = get_last_dump()
245
246 if shamrock.sys.world_rank() == 0:
247 print("Last dump:", idump_last_dump)
Last dump: None
Load the last dump if it exists, setup otherwise
252 if idump_last_dump is not None:
253 model.load_from_dump(get_dump_name(idump_last_dump))
254 else:
255 # Generate the default config
256 cfg = model.gen_default_config()
257 cfg.set_artif_viscosity_ConstantDisc(alpha_u=alpha_u, alpha_AV=alpha_AV, beta_AV=beta_AV)
258 cfg.set_eos_locally_isothermalLP07(cs0=cs0, q=q, r0=r0)
259
260 # cfg.add_ext_force_point_mass(center_mass, center_racc)
261
262 cfg.add_kill_sphere(center=(0, 0, 0), radius=bsize) # kill particles outside the simulation box
263 cfg.add_ext_force_lense_thirring(
264 central_mass=center_mass,
265 Racc=rin,
266 a_spin=0.9,
267 dir_spin=(np.sin(inclination), np.cos(inclination), 0.0),
268 )
269
270 cfg.set_units(codeu)
271 cfg.set_particle_mass(pmass)
272 # Set the CFL
273 cfg.set_cfl_cour(C_cour)
274 cfg.set_cfl_force(C_force)
275
276 # On a chaotic disc, we disable to two stage search to avoid giant leaves
277 cfg.set_tree_reduction_level(6)
278 cfg.set_two_stage_search(False)
279
280 # Enable this to debug the neighbor counts
281 # cfg.set_show_neigh_stats(True)
282
283 # Standard way to set the smoothing length (e.g. Price et al. 2018)
284 cfg.set_smoothing_length_density_based()
285
286 # Standard density based smoothing lenght but with a neighbor count limit
287 # Use it if you have large slowdowns due to giant particles
288 # I recommend to use it if you have a circumbinary discs as the issue is very likely to happen
289 # cfg.set_smoothing_length_density_based_neigh_lim(500)
290
291 # Set the solver config to be the one stored in cfg
292 model.set_solver_config(cfg)
293
294 # Print the solver config
295 model.get_current_config().print_status()
296
297 # Init the scheduler & fields
298 model.init_scheduler(scheduler_split_val, scheduler_merge_val)
299
300 # Set the simulation box size
301 model.resize_simulation_box(bmin, bmax)
302
303 # Create the setup
304
305 setup = model.get_setup()
306 gen_disc = setup.make_generator_disc_mc(
307 part_mass=pmass,
308 disc_mass=disc_mass,
309 r_in=rin,
310 r_out=rout,
311 sigma_profile=sigma_profile,
312 H_profile=H_profile,
313 rot_profile=rot_profile,
314 cs_profile=cs_profile,
315 random_seed=666,
316 init_h_factor=0.06,
317 )
318
319 # Print the dot graph of the setup
320 print(gen_disc.get_dot())
321
322 # Apply the setup
323 setup.apply_setup(gen_disc)
324
325 # correct the momentum and barycenter of the disc to 0
326 analysis_momentum = shamrock.model_sph.analysisTotalMomentum(model=model)
327 total_momentum = analysis_momentum.get_total_momentum()
328
329 if shamrock.sys.world_rank() == 0:
330 print(f"disc momentum = {total_momentum}")
331
332 model.apply_momentum_offset((-total_momentum[0], -total_momentum[1], -total_momentum[2]))
333
334 # Correct the barycenter
335 analysis_barycenter = shamrock.model_sph.analysisBarycenter(model=model)
336 barycenter, disc_mass = analysis_barycenter.get_barycenter()
337
338 if shamrock.sys.world_rank() == 0:
339 print(f"disc barycenter = {barycenter}")
340
341 model.apply_position_offset((-barycenter[0], -barycenter[1], -barycenter[2]))
342
343 total_momentum = shamrock.model_sph.analysisTotalMomentum(model=model).get_total_momentum()
344
345 if shamrock.sys.world_rank() == 0:
346 print(f"disc momentum after correction = {total_momentum}")
347
348 barycenter, disc_mass = shamrock.model_sph.analysisBarycenter(model=model).get_barycenter()
349
350 if shamrock.sys.world_rank() == 0:
351 print(f"disc barycenter after correction = {barycenter}")
352
353 if not np.allclose(total_momentum, 0.0):
354 raise RuntimeError("disc momentum is not 0")
355 if not np.allclose(barycenter, 0.0):
356 raise RuntimeError("disc barycenter is not 0")
357
358 # Run a single step to init the integrator and smoothing length of the particles
359 # Here the htolerance is the maximum factor of evolution of the smoothing length in each
360 # Smoothing length iterations, increasing it affect the performance negatively but increse the
361 # convergence rate of the smoothing length
362 # this is why we increase it temporely to 1.3 before lowering it back to 1.1 (default value)
363 # Note that both ``change_htolerances`` can be removed and it will work the same but would converge
364 # more slowly at the first timestep
365
366 model.change_htolerances(coarse=1.3, fine=1.1)
367 model.timestep()
368 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": 1.0019944020500018e-05,
"eos_type": "locally_isothermal_lp07",
"q": 0.75,
"r0": 0.03948371767577914
},
"epsilon_h": 1e-06,
"ext_force_config": {
"force_list": [
{
"Racc": 0.03948371767577914,
"a_spin": 0.9,
"central_mass": 1000000.0,
"dir_spin": [
0.49999999999999994,
0.8660254037844387,
0.0
],
"force_type": "lense_thirring"
}
]
},
"gpart_mass": 1e-08,
"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": 0.7896743535155828,
"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": 6,
"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": 1.0
},
"use_two_stage_search": false
}
]
------------------------------------
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 25.61 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 : 8.00 us (60.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 : 1413.00 ns (0.3%)
patch tree reduce : 1162.00 ns (0.2%)
gen split merge : 601.00 ns (0.1%)
split / merge op : 0/0
apply split merge : 892.00 ns (0.2%)
LB compute : 520.46 us (97.8%)
LB move op cnt : 0
LB apply : 3.41 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 : 3.13 us (62.9%)
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 : 1723.00 ns (0.4%)
patch tree reduce : 611.00 ns (0.2%)
gen split merge : 411.00 ns (0.1%)
split / merge op : 0/0
apply split merge : 270.00 ns (0.1%)
LB compute : 393.94 us (97.9%)
LB move op cnt : 0
LB apply : 2.25 us (0.6%)
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.60 us (66.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 : 1813.00 ns (0.4%)
patch tree reduce : 351.00 ns (0.1%)
gen split merge : 411.00 ns (0.1%)
split / merge op : 0/0
apply split merge : 261.00 ns (0.1%)
LB compute : 395.77 us (98.1%)
LB move op cnt : 0
LB apply : 1834.00 ns (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 (67.9%)
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 : 1763.00 ns (0.5%)
patch tree reduce : 351.00 ns (0.1%)
gen split merge : 391.00 ns (0.1%)
split / merge op : 0/0
apply split merge : 250.00 ns (0.1%)
LB compute : 355.51 us (98.0%)
LB move op cnt : 0
LB apply : 1723.00 ns (0.5%)
Info: the setup took : 0.346466828 s [SPH setup][rank=0]
disc momentum = (2.5675588663788727e-10, 2.2047388731335174e-09, 0.0)
disc barycenter = (0.00053613223666843, -0.00038151734517661917, 2.4807838934395508e-06)
disc momentum after correction = (6.203854594147708e-23, 6.627784658081134e-23, 0.0)
disc barycenter after correction = (-9.740878893424454e-18, 2.5728625772849373e-17, -2.2251158477676444e-19)
---------------- 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 : 6.35 us (1.4%)
patch tree reduce : 1092.00 ns (0.2%)
gen split merge : 791.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1182.00 ns (0.3%)
LB compute : 419.31 us (95.6%)
LB move op cnt : 0
LB apply : 3.36 us (0.8%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.73 us (70.5%)
central potential accretion : += 4.4e-07
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.00900994070861709 unconverged cnt = 99947
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.00916897508625909 unconverged cnt = 99925
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.00916897508625909 unconverged cnt = 99893
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.009173539640934479 unconverged cnt = 99756
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.00917353964093448 unconverged cnt = 99364
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.009173539640934482 unconverged cnt = 98013
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010149085311974134 unconverged cnt = 92661
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010149085311974134 unconverged cnt = 65319
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010149085311974134 unconverged cnt = 11468
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010149085311974134 unconverged cnt = 135
Info: conservation infos : [sph::Model][rank=0]
sum v = (-2.5790461243403894e-10,-2.5612767679825245e-10,0)
sum a = (-2.7488526880990904e-11,-5.155579937370071e-12,6.253541185801623e-12)
sum e = 1.2852649664182196e-10
sum de = -2.400743547377337e-16
Info: CFL hydro = 0.015252131995279429 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.015252131995279429 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 | 4.4555e+04 | 99956 | 2.243e+00 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 0 (tsim/hr) [sph::Model][rank=0]
On the fly analysis
373 def save_rho_integ(ext, arr_rho, iplot):
374 if shamrock.sys.world_rank() == 0:
375 metadata = {"extent": [-ext, ext, -ext, ext], "time": model.get_time()}
376 np.save(plot_folder + f"rho_integ_{iplot:07}.npy", arr_rho)
377
378 with open(plot_folder + f"rho_integ_{iplot:07}.json", "w") as fp:
379 json.dump(metadata, fp)
380
381
382 def save_vxyz_integ(ext, arr_vxyz, iplot):
383 if shamrock.sys.world_rank() == 0:
384 metadata = {"extent": [-ext, ext, -ext, ext], "time": model.get_time()}
385 np.save(plot_folder + f"vxyz_integ_{iplot:07}.npy", arr_vxyz)
386
387 with open(plot_folder + f"vxyz_integ_{iplot:07}.json", "w") as fp:
388 json.dump(metadata, fp)
389
390
391 def save_analysis_data(filename, key, value, ianalysis):
392 """Helper to save analysis data to a JSON file."""
393 if shamrock.sys.world_rank() == 0:
394 filepath = os.path.join(analysis_folder, filename)
395 try:
396 with open(filepath, "r") as fp:
397 data = json.load(fp)
398 except (FileNotFoundError, json.JSONDecodeError):
399 data = {key: []}
400 data[key] = data[key][:ianalysis]
401 data[key].append({"t": model.get_time(), key: value})
402 with open(filepath, "w") as fp:
403 json.dump(data, fp, indent=4)
404
405
406 def analysis(ianalysis):
407
408 ext = rout * 1.5
409 nx = 1024
410 ny = 1024
411
412 arr_rho2 = model.render_cartesian_column_integ(
413 "rho",
414 "f64",
415 center=(0.0, 0.0, 0.0),
416 delta_x=(ext * 2, 0, 0.0),
417 delta_y=(0.0, ext * 2, 0.0),
418 nx=nx,
419 ny=ny,
420 )
421
422 arr_vxyz = model.render_cartesian_column_integ(
423 "vxyz",
424 "f64_3",
425 center=(0.0, 0.0, 0.0),
426 delta_x=(ext * 2, 0, 0.0),
427 delta_y=(0.0, ext * 2, 0.0),
428 nx=nx,
429 ny=ny,
430 )
431
432 save_rho_integ(ext, arr_rho2, ianalysis)
433 save_vxyz_integ(ext, arr_vxyz, ianalysis)
434
435 barycenter, disc_mass = shamrock.model_sph.analysisBarycenter(model=model).get_barycenter()
436
437 total_momentum = shamrock.model_sph.analysisTotalMomentum(model=model).get_total_momentum()
438
439 potential_energy = shamrock.model_sph.analysisEnergyPotential(
440 model=model
441 ).get_potential_energy()
442
443 kinetic_energy = shamrock.model_sph.analysisEnergyKinetic(model=model).get_kinetic_energy()
444
445 save_analysis_data("barycenter.json", "barycenter", barycenter, ianalysis)
446 save_analysis_data("disc_mass.json", "disc_mass", disc_mass, ianalysis)
447 save_analysis_data("total_momentum.json", "total_momentum", total_momentum, ianalysis)
448 save_analysis_data("potential_energy.json", "potential_energy", potential_energy, ianalysis)
449 save_analysis_data("kinetic_energy.json", "kinetic_energy", kinetic_energy, ianalysis)
450
451 sim_time_delta = model.solver_logs_cumulated_step_time()
452 scount = model.solver_logs_step_count()
453
454 save_analysis_data("sim_time_delta.json", "sim_time_delta", sim_time_delta, ianalysis)
455 save_analysis_data("sim_step_count_delta.json", "sim_step_count_delta", scount, ianalysis)
456
457 model.solver_logs_reset_cumulated_step_time()
458 model.solver_logs_reset_step_count()
459
460 part_count = model.get_total_part_count()
461 save_analysis_data("part_count.json", "part_count", part_count, ianalysis)
Evolve the simulation
466 model.solver_logs_reset_cumulated_step_time()
467 model.solver_logs_reset_step_count()
468
469 t_start = model.get_time()
470
471 idump = 0
472 iplot = 0
473 istop = 0
474 for ttarg in t_stop:
475
476 if ttarg >= t_start:
477 model.evolve_until(ttarg)
478
479 if istop % dump_freq_stop == 0:
480 model.do_vtk_dump(get_vtk_dump_name(idump), True)
481 model.dump(get_dump_name(idump))
482
483 # dump = model.make_phantom_dump()
484 # dump.save_dump(get_ph_dump_name(idump))
485
486 purge_old_dumps()
487
488 if istop % plot_freq_stop == 0:
489 analysis(iplot)
490
491 if istop % dump_freq_stop == 0:
492 idump += 1
493
494 if istop % plot_freq_stop == 0:
495 iplot += 1
496
497 istop += 1
Info: iteration since start : 1 [SPH][rank=0]
Info: time since start : 1343.069255409 (s) [SPH][rank=0]
Info: dump to _to_trash/black_hole_disc_lense_thirring_100000/dump/dump_0000000.vtk [VTK Dump][rank=0]
- took 30.17 ms, bandwidth = 176.96 MB/s
Info: Dumping state to _to_trash/black_hole_disc_lense_thirring_100000/dump/dump_0000000.sham [SPH][rank=0]
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 15.65 us (50.0%)
Info: dump to _to_trash/black_hole_disc_lense_thirring_100000/dump/dump_0000000.sham [Shamrock Dump][rank=0]
- took 50.49 ms, bandwidth = 226.69 MB/s
Info: compute_column_integ field_name: rho, center: (0,0,0), delta_x: (1.1845115302733742,0,0), delta_y: (0,1.1845115302733742,0), nx: 1024, ny: 1024 [sph::CartesianRender][rank=0]
Info: compute_column_integ took 664.64 ms [sph::CartesianRender][rank=0]
Info: compute_column_integ field_name: vxyz, center: (0,0,0), delta_x: (1.1845115302733742,0,0), delta_y: (0,1.1845115302733742,0), nx: 1024, ny: 1024 [sph::CartesianRender][rank=0]
Info: compute_column_integ took 658.79 ms [sph::CartesianRender][rank=0]
---------------- t = 0, dt = 0.015252131995279429 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99956 min = 99956 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99956 min = 99956 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99956
max = 99956
avg = 99956
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 8.05 us (1.6%)
patch tree reduce : 14.50 us (2.9%)
gen split merge : 812.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1172.00 ns (0.2%)
LB compute : 460.17 us (92.5%)
LB move op cnt : 0
LB apply : 4.21 us (0.8%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.83 us (70.1%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-2.5832387107439586e-10,-2.5620631038406046e-10,9.537983560376342e-14)
sum a = (-2.748430887236466e-11,-5.161052417488452e-12,6.252290265894782e-12)
sum e = 1.2852649589162583e-10
sum de = -2.396800528037773e-16
Info: CFL hydro = 0.5185425517226135 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.5185425517226135 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 | 2.5854e+05 | 99956 | 3.866e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 142.0185367126722 (tsim/hr) [sph::Model][rank=0]
---------------- t = 0.015252131995279429, dt = 0.5185425517226135 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99956 min = 99956 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99956 min = 99956 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99956
max = 99956
avg = 99956
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.49 us (1.6%)
patch tree reduce : 1823.00 ns (0.4%)
gen split merge : 851.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1473.00 ns (0.3%)
LB compute : 457.65 us (95.4%)
LB move op cnt : 0
LB apply : 3.55 us (0.7%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.65 us (72.2%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-2.725756225626358e-10,-2.588825774077566e-10,3.3374488445935397e-12)
sum a = (-2.7341915186490648e-11,-5.345073340419528e-12,6.209208348935317e-12)
sum e = 1.2852973394516008e-10
sum de = -2.266774787310398e-16
Info: CFL hydro = 0.8524887737130544 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.8524887737130544 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 | 2.6160e+05 | 99956 | 3.821e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 4885.666225926913 (tsim/hr) [sph::Model][rank=0]
---------------- t = 0.533794683717893, dt = 0.8524887737130544 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99956 min = 99956 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99956 min = 99956 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99956
max = 99956
avg = 99956
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.37 us (1.7%)
patch tree reduce : 1613.00 ns (0.4%)
gen split merge : 772.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1292.00 ns (0.3%)
LB compute : 358.27 us (94.7%)
LB move op cnt : 0
LB apply : 3.28 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.37 us (72.5%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-2.9584737971835304e-10,-2.6348690376456843e-10,8.619559352129778e-12)
sum a = (-2.7112879049639808e-11,-5.639087038521053e-12,6.134950311562923e-12)
sum e = 1.2853527459515071e-10
sum de = -2.0624300272387858e-16
Info: CFL hydro = 1.0731315001181247 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.0731315001181247 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 | 2.6618e+05 | 99956 | 3.755e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 8172.465464639422 (tsim/hr) [sph::Model][rank=0]
---------------- t = 1.3862834574309475, dt = 1.0731315001181247 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99956 min = 99956 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99956 min = 99956 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99956
max = 99956
avg = 99956
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.19 us (1.9%)
patch tree reduce : 1232.00 ns (0.3%)
gen split merge : 681.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 962.00 ns (0.3%)
LB compute : 363.54 us (94.6%)
LB move op cnt : 0
LB apply : 3.38 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.38 us (71.4%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-3.2484543891771634e-10,-2.696637073858882e-10,1.517151571151833e-11)
sum a = (-2.683423140504078e-11,-5.994837744201777e-12,6.0359709303560146e-12)
sum e = 1.2854038129715343e-10
sum de = -1.809274274541857e-16
Info: CFL hydro = 1.2190623639153157 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.2190623639153157 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 | 2.6578e+05 | 99956 | 3.761e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 10272.396760226668 (tsim/hr) [sph::Model][rank=0]
---------------- t = 2.4594149575490722, dt = 1.2190623639153157 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99956 min = 99956 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99956 min = 99956 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99956
max = 99956
avg = 99956
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.18 us (1.7%)
patch tree reduce : 1233.00 ns (0.3%)
gen split merge : 751.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 981.00 ns (0.3%)
LB compute : 344.05 us (94.7%)
LB move op cnt : 0
LB apply : 3.57 us (1.0%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.20 us (71.7%)
central potential accretion : += 1e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-3.671538596915036e-10,-2.79175187063028e-10,2.2809960394220996e-11)
sum a = (-2.6480953695194313e-11,-6.628545458772638e-12,6.004931758887468e-12)
sum e = 1.2853940735418083e-10
sum de = -1.5529330144007234e-16
Info: CFL hydro = 1.3162977733589818 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.3162977733589818 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 | 2.6253e+05 | 99955 | 3.807e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 11526.85291962314 (tsim/hr) [sph::Model][rank=0]
---------------- t = 3.678477321464388, dt = 1.3162977733589818 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99955 min = 99955 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99955 min = 99955 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99955
max = 99955
avg = 99955
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 8.06 us (2.3%)
patch tree reduce : 1714.00 ns (0.5%)
gen split merge : 711.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1243.00 ns (0.4%)
LB compute : 330.01 us (93.4%)
LB move op cnt : 0
LB apply : 3.43 us (1.0%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.17 us (68.7%)
central potential accretion : += 2e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-4.2151178267431726e-10,-2.8514205529942213e-10,3.173594452040185e-11)
sum a = (-2.6236311853296366e-11,-7.525051124800201e-12,6.08268892925953e-12)
sum e = 1.2853232033527092e-10
sum de = -1.3213867220814462e-16
Info: CFL hydro = 1.3822079865303833 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.3822079865303833 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 | 2.6272e+05 | 99953 | 3.805e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 12455.093596170876 (tsim/hr) [sph::Model][rank=0]
---------------- t = 4.994775094823369, dt = 1.3822079865303833 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99953 min = 99953 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99953 min = 99953 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99953
max = 99953
avg = 99953
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 8.12 us (2.2%)
patch tree reduce : 1513.00 ns (0.4%)
gen split merge : 731.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1243.00 ns (0.3%)
LB compute : 348.92 us (93.8%)
LB move op cnt : 0
LB apply : 3.72 us (1.0%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.22 us (70.0%)
central potential accretion : += 1e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-4.670416693063723e-10,-2.987570579270609e-10,4.059634040298324e-11)
sum a = (-2.5827922418632666e-11,-8.164078097230883e-12,6.011497469862704e-12)
sum e = 1.285294348731032e-10
sum de = -1.0184580398776579e-16
Info: CFL hydro = 1.42823402297779 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.42823402297779 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 | 2.6087e+05 | 99952 | 3.831e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 12987.048132256186 (tsim/hr) [sph::Model][rank=0]
---------------- t = 6.376983081353753, dt = 1.42823402297779 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99952 min = 99952 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99952 min = 99952 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99952
max = 99952
avg = 99952
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.72 us (1.7%)
patch tree reduce : 1673.00 ns (0.4%)
gen split merge : 792.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1192.00 ns (0.3%)
LB compute : 370.62 us (94.7%)
LB move op cnt : 0
LB apply : 3.53 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.67 us (70.3%)
central potential accretion : += 2e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-5.184828678353387e-10,-3.187351515574714e-10,5.000879100512797e-11)
sum a = (-2.5290219195780556e-11,-8.933256285276131e-12,5.954870248703064e-12)
sum e = 1.2852105057515668e-10
sum de = -7.323792755626592e-17
Info: CFL hydro = 1.4616790540726354 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.4616790540726354 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 | 2.6286e+05 | 99950 | 3.802e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 13521.930949658365 (tsim/hr) [sph::Model][rank=0]
---------------- t = 7.805217104331543, dt = 1.4616790540726354 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99950 min = 99950 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99950 min = 99950 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99950
max = 99950
avg = 99950
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.57 us (2.0%)
patch tree reduce : 1573.00 ns (0.4%)
gen split merge : 1252.00 ns (0.3%)
split / merge op : 0/0
apply split merge : 1523.00 ns (0.4%)
LB compute : 356.70 us (93.8%)
LB move op cnt : 0
LB apply : 3.44 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.40 us (72.1%)
central potential accretion : += 2e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-5.704769021354244e-10,-3.4357710212172e-10,5.961594972099954e-11)
sum a = (-2.4671766876996627e-11,-9.697434329828952e-12,5.871870698244595e-12)
sum e = 1.2851233166820949e-10
sum de = -4.3174012420916164e-17
Info: CFL hydro = 1.4873604425853453 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.4873604425853453 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 | 2.6287e+05 | 99948 | 3.802e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 13839.670477086369 (tsim/hr) [sph::Model][rank=0]
---------------- t = 9.26689615840418, dt = 1.4873604425853453 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99948 min = 99948 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99948 min = 99948 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99948
max = 99948
avg = 99948
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.41 us (1.7%)
patch tree reduce : 1754.00 ns (0.5%)
gen split merge : 751.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1062.00 ns (0.3%)
LB compute : 367.00 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.25 us (69.2%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-6.069326075841021e-10,-3.5826469765873405e-10,6.822054327706472e-11)
sum a = (-2.4355294205514424e-11,-1.0050968846145195e-11,5.694320118579238e-12)
sum e = 1.2851324501755906e-10
sum de = -5.051611018353456e-18
Info: CFL hydro = 1.5082353185282555 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.5082353185282555 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 | 2.6272e+05 | 99948 | 3.804e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 14074.855182258845 (tsim/hr) [sph::Model][rank=0]
---------------- t = 10.754256600989525, dt = 1.5082353185282555 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99948 min = 99948 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99948 min = 99948 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99948
max = 99948
avg = 99948
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 8.44 us (2.2%)
patch tree reduce : 1843.00 ns (0.5%)
gen split merge : 1042.00 ns (0.3%)
split / merge op : 0/0
apply split merge : 1492.00 ns (0.4%)
LB compute : 366.45 us (93.8%)
LB move op cnt : 0
LB apply : 3.63 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.24 us (69.6%)
central potential accretion : += 1e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-6.509403765528402e-10,-3.801370907832197e-10,7.7344744701998e-11)
sum a = (-2.390214811831088e-11,-1.0589221773014513e-11,5.558194917162884e-12)
sum e = 1.2850913436490332e-10
sum de = 3.024395281701608e-17
Info: CFL hydro = 1.526282928465022 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.526282928465022 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 | 2.6249e+05 | 99947 | 3.808e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 14259.882533850183 (tsim/hr) [sph::Model][rank=0]
---------------- t = 12.26249191951778, dt = 1.526282928465022 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99947 min = 99947 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99947 min = 99947 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99947
max = 99947
avg = 99947
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.20 us (1.7%)
patch tree reduce : 1603.00 ns (0.4%)
gen split merge : 752.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 971.00 ns (0.3%)
LB compute : 352.38 us (94.7%)
LB move op cnt : 0
LB apply : 3.43 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.40 us (70.3%)
central potential accretion : += 1e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-6.968414419845893e-10,-3.9880715640441613e-10,8.700391212344432e-11)
sum a = (-2.3569996235180987e-11,-1.1169589962042578e-11,5.467796869012158e-12)
sum e = 1.2850491629055437e-10
sum de = 6.540406644354686e-17
Info: CFL hydro = 1.5428048753535588 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.5428048753535588 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 | 2.6223e+05 | 99946 | 3.811e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 14416.37786533845 (tsim/hr) [sph::Model][rank=0]
---------------- t = 13.788774847982802, dt = 1.5428048753535588 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99946 min = 99946 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99946 min = 99946 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99946
max = 99946
avg = 99946
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.10 us (1.9%)
patch tree reduce : 1453.00 ns (0.4%)
gen split merge : 692.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1092.00 ns (0.3%)
LB compute : 346.89 us (94.4%)
LB move op cnt : 0
LB apply : 3.73 us (1.0%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.36 us (71.5%)
central potential accretion : += 1e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010152894469516805 unconverged cnt = 1
Info: conservation infos : [sph::Model][rank=0]
sum v = (-7.422854360683832e-10,-4.128354309533293e-10,9.696338426715578e-11)
sum a = (-2.3400244910286796e-11,-1.1750369711996793e-11,5.405051290764528e-12)
sum e = 1.2850063988263093e-10
sum de = 1.0058060756748317e-16
Info: CFL hydro = 1.5586281580460652 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.5586281580460652 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.6522e+05 | 99945 | 6.049e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 9181.389250277422 (tsim/hr) [sph::Model][rank=0]
---------------- t = 15.331579723336361, dt = 1.5586281580460652 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99945 min = 99945 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99945 min = 99945 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99945
max = 99945
avg = 99945
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.54 us (1.9%)
patch tree reduce : 1563.00 ns (0.4%)
gen split merge : 831.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 981.00 ns (0.3%)
LB compute : 331.99 us (94.3%)
LB move op cnt : 0
LB apply : 3.38 us (1.0%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.56 us (68.7%)
central potential accretion : += 3.0000000000000004e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010153255865648995 unconverged cnt = 3
Info: conservation infos : [sph::Model][rank=0]
sum v = (-7.911536502483691e-10,-4.554283721017448e-10,1.0620705283889967e-10)
sum a = (-2.2552119026321705e-11,-1.241394088345591e-11,5.2383787057291464e-12)
sum e = 1.2848669594338594e-10
sum de = 1.290708061940019e-16
Info: CFL hydro = 1.5717116140573049 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.5717116140573049 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.5980e+05 | 99942 | 6.254e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 8971.503575265497 (tsim/hr) [sph::Model][rank=0]
---------------- t = 16.890207881382427, dt = 1.5717116140573049 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99942 min = 99942 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99942 min = 99942 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99942
max = 99942
avg = 99942
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.61 us (1.8%)
patch tree reduce : 1332.00 ns (0.4%)
gen split merge : 822.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1012.00 ns (0.3%)
LB compute : 353.49 us (94.6%)
LB move op cnt : 0
LB apply : 3.21 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.33 us (69.2%)
central potential accretion : += 4e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-8.602085096580945e-10,-4.882803168950269e-10,1.2023531197305748e-10)
sum a = (-2.197968445284378e-11,-1.3608227742411306e-11,5.325510537540225e-12)
sum e = 1.2846754468033483e-10
sum de = 1.5050555183775077e-16
Info: CFL hydro = 1.5816907895337893 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.5816907895337893 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 | 2.5934e+05 | 99938 | 3.854e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 14683.0902236994 (tsim/hr) [sph::Model][rank=0]
---------------- t = 18.46191949543973, dt = 1.5816907895337893 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99938 min = 99938 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99938 min = 99938 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99938
max = 99938
avg = 99938
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.01 us (1.9%)
patch tree reduce : 1413.00 ns (0.4%)
gen split merge : 822.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 962.00 ns (0.3%)
LB compute : 340.00 us (94.3%)
LB move op cnt : 0
LB apply : 3.35 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.69 us (69.9%)
central potential accretion : += 6.000000000000001e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010153972518172157 unconverged cnt = 3
Info: conservation infos : [sph::Model][rank=0]
sum v = (-9.05890364960065e-10,-5.482924473972308e-10,1.287689111735579e-10)
sum a = (-2.0741095017904637e-11,-1.418243153531365e-11,5.074764571897024e-12)
sum e = 1.2843857302946497e-10
sum de = 1.656587481415128e-16
Info: CFL hydro = 1.5922793439104768 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.5922793439104768 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.6469e+05 | 99932 | 6.068e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 9383.73422332104 (tsim/hr) [sph::Model][rank=0]
---------------- t = 20.043610284973518, dt = 1.5922793439104768 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99932 min = 99932 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99932 min = 99932 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99932
max = 99932
avg = 99932
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.42 us (1.8%)
patch tree reduce : 1332.00 ns (0.4%)
gen split merge : 732.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 992.00 ns (0.3%)
LB compute : 340.15 us (94.5%)
LB move op cnt : 0
LB apply : 3.61 us (1.0%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.31 us (70.2%)
central potential accretion : += 3.0000000000000004e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.01015432700953243 unconverged cnt = 2
Info: conservation infos : [sph::Model][rank=0]
sum v = (-9.523686087665113e-10,-5.735999162496426e-10,1.3954999662117805e-10)
sum a = (-2.0444327485975928e-11,-1.4834294986508422e-11,5.0243143972457755e-12)
sum e = 1.2842422606023483e-10
sum de = 1.9133677889256423e-16
Info: CFL hydro = 1.6034924202523615 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.6034924202523615 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.6492e+05 | 99929 | 6.059e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 9460.39827091796 (tsim/hr) [sph::Model][rank=0]
---------------- t = 21.635889628883994, dt = 1.6034924202523615 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99929 min = 99929 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99929 min = 99929 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99929
max = 99929
avg = 99929
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 8.49 us (2.1%)
patch tree reduce : 1502.00 ns (0.4%)
gen split merge : 812.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1373.00 ns (0.3%)
LB compute : 377.48 us (94.0%)
LB move op cnt : 0
LB apply : 4.09 us (1.0%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.42 us (72.3%)
central potential accretion : += 2e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.0016330990066828e-09,-6.079280666188756e-10,1.5105071363903174e-10)
sum a = (-1.9984790634533713e-11,-1.5554966007774572e-11,4.978152810965331e-12)
sum e = 1.2841506808170412e-10
sum de = 2.232705028833151e-16
Info: CFL hydro = 1.6154422686827206 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.6154422686827206 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 | 2.5933e+05 | 99927 | 3.853e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 14980.897197184056 (tsim/hr) [sph::Model][rank=0]
---------------- t = 23.239382049136356, dt = 1.519590083414787 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99927 min = 99927 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99927 min = 99927 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99927
max = 99927
avg = 99927
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.71 us (2.1%)
patch tree reduce : 1813.00 ns (0.5%)
gen split merge : 1001.00 ns (0.3%)
split / merge op : 0/0
apply split merge : 1182.00 ns (0.3%)
LB compute : 342.85 us (93.5%)
LB move op cnt : 0
LB apply : 3.89 us (1.1%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.19 us (69.3%)
central potential accretion : += 1e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.040665120897025e-09,-6.359429618391507e-10,1.605684164104068e-10)
sum a = (-1.9703342060028133e-11,-1.60708798808771e-11,4.913465485982526e-12)
sum e = 1.2840722888857062e-10
sum de = 2.5982706696315827e-16
Info: CFL hydro = 1.627428185719446 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.627428185719446 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 | 2.6201e+05 | 99926 | 3.814e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 14344.158451767124 (tsim/hr) [sph::Model][rank=0]
Info: iteration since start : 20 [SPH][rank=0]
Info: time since start : 1352.836206599 (s) [SPH][rank=0]
Info: dump to _to_trash/black_hole_disc_lense_thirring_100000/dump/dump_0000001.vtk [VTK Dump][rank=0]
- took 7.93 ms, bandwidth = 672.63 MB/s
Info: Dumping state to _to_trash/black_hole_disc_lense_thirring_100000/dump/dump_0000001.sham [SPH][rank=0]
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.06 us (51.4%)
Info: dump to _to_trash/black_hole_disc_lense_thirring_100000/dump/dump_0000001.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: (1.1845115302733742,0,0), delta_y: (0,1.1845115302733742,0), nx: 1024, ny: 1024 [sph::CartesianRender][rank=0]
Info: compute_column_integ took 636.71 ms [sph::CartesianRender][rank=0]
Info: compute_column_integ field_name: vxyz, center: (0,0,0), delta_x: (1.1845115302733742,0,0), delta_y: (0,1.1845115302733742,0), nx: 1024, ny: 1024 [sph::CartesianRender][rank=0]
Info: compute_column_integ took 633.83 ms [sph::CartesianRender][rank=0]
---------------- t = 24.758972132551143, dt = 1.627428185719446 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99926 min = 99926 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99926 min = 99926 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99926
max = 99926
avg = 99926
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.78 us (1.3%)
patch tree reduce : 1533.00 ns (0.3%)
gen split merge : 781.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1252.00 ns (0.2%)
LB compute : 493.01 us (95.9%)
LB move op cnt : 0
LB apply : 3.37 us (0.7%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.96 us (72.0%)
central potential accretion : += 4e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010155355260076552 unconverged cnt = 1
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.0683468067673697e-09,-6.941184436090445e-10,1.656163164866214e-10)
sum a = (-1.8724461279483024e-11,-1.6247902067154887e-11,4.605987525831523e-12)
sum e = 1.2839216619304811e-10
sum de = 2.789643928736606e-16
Info: CFL hydro = 1.6409655845076239 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.6409655845076239 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.6491e+05 | 99922 | 6.059e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 9669.272216062256 (tsim/hr) [sph::Model][rank=0]
---------------- t = 26.38640031827059, dt = 1.6409655845076239 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99922 min = 99922 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99922 min = 99922 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99922
max = 99922
avg = 99922
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.10 us (1.6%)
patch tree reduce : 1282.00 ns (0.3%)
gen split merge : 772.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1052.00 ns (0.3%)
LB compute : 362.93 us (95.0%)
LB move op cnt : 0
LB apply : 3.21 us (0.8%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.21 us (70.9%)
central potential accretion : += 9e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010155700244677013 unconverged cnt = 7
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.123517022769173e-09,-7.636548972278623e-10,1.7790145366439259e-10)
sum a = (-1.747116179812116e-11,-1.7217289953707263e-11,4.476551603368143e-12)
sum e = 1.2834846513941324e-10
sum de = 2.642437752415226e-16
Info: CFL hydro = 1.6555361875753443 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.6555361875753443 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.6394e+05 | 99913 | 6.094e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 9693.183954248823 (tsim/hr) [sph::Model][rank=0]
---------------- t = 28.02736590277821, dt = 1.6555361875753443 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99913 min = 99913 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99913 min = 99913 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99913
max = 99913
avg = 99913
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.73 us (1.9%)
patch tree reduce : 1362.00 ns (0.4%)
gen split merge : 812.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1012.00 ns (0.3%)
LB compute : 326.77 us (94.3%)
LB move op cnt : 0
LB apply : 3.17 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.58 us (70.1%)
central potential accretion : += 4e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010156042993858406 unconverged cnt = 3
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.154214386268243e-09,-8.196270965279213e-10,1.8472230191733243e-10)
sum a = (-1.659066839943074e-11,-1.7578668102584897e-11,4.2650114541541506e-12)
sum e = 1.28329734268458e-10
sum de = 2.73382543847551e-16
Info: CFL hydro = 1.6711839943087936 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.6711839943087936 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.6477e+05 | 99909 | 6.064e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 9828.978547292956 (tsim/hr) [sph::Model][rank=0]
---------------- t = 29.682902090353554, dt = 1.6711839943087936 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99909 min = 99909 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99909 min = 99909 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99909
max = 99909
avg = 99909
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 8.29 us (2.2%)
patch tree reduce : 1513.00 ns (0.4%)
gen split merge : 1112.00 ns (0.3%)
split / merge op : 0/0
apply split merge : 1302.00 ns (0.4%)
LB compute : 344.50 us (93.4%)
LB move op cnt : 0
LB apply : 3.58 us (1.0%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.27 us (69.8%)
central potential accretion : += 5e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010156383592595864 unconverged cnt = 1
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.1650056907667287e-09,-8.714759934654416e-10,1.8566863571775585e-10)
sum a = (-1.586087133468016e-11,-1.7395811158534058e-11,3.966873767570558e-12)
sum e = 1.2830619760818265e-10
sum de = 2.7260214846476075e-16
Info: CFL hydro = 1.6660771971491062 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.6660771971491062 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.6361e+05 | 99904 | 6.106e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 9852.760469568662 (tsim/hr) [sph::Model][rank=0]
---------------- t = 31.35408608466235, dt = 1.6660771971491062 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99904 min = 99904 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99904 min = 99904 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99904
max = 99904
avg = 99904
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 8.23 us (2.2%)
patch tree reduce : 2.21 us (0.6%)
gen split merge : 962.00 ns (0.3%)
split / merge op : 0/0
apply split merge : 1222.00 ns (0.3%)
LB compute : 358.29 us (93.6%)
LB move op cnt : 0
LB apply : 3.67 us (1.0%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.58 us (66.0%)
central potential accretion : += 4e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010156717768368765 unconverged cnt = 2
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.1894610687533558e-09,-9.209837898911315e-10,1.911227934426189e-10)
sum a = (-1.523016806683113e-11,-1.7647509107329736e-11,3.817200056082965e-12)
sum e = 1.2828656938981515e-10
sum de = 2.7885197068315983e-16
Info: CFL hydro = 1.6036369027730912 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.6036369027730912 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.6457e+05 | 99900 | 6.070e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 9880.869590328404 (tsim/hr) [sph::Model][rank=0]
---------------- t = 33.020163281811456, dt = 1.6036369027730912 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99900 min = 99900 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99900 min = 99900 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99900
max = 99900
avg = 99900
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.91 us (1.9%)
patch tree reduce : 1242.00 ns (0.3%)
gen split merge : 802.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1052.00 ns (0.3%)
LB compute : 350.99 us (94.5%)
LB move op cnt : 0
LB apply : 3.27 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.42 us (72.0%)
central potential accretion : += 5e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.01015703435298611 unconverged cnt = 5
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.2285029830989142e-09,-9.504008921401025e-10,2.019319988086532e-10)
sum a = (-1.5115635948967993e-11,-1.8394045561406295e-11,3.889987941163923e-12)
sum e = 1.28259299699102e-10
sum de = 2.794918284587949e-16
Info: CFL hydro = 1.722829340312868 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.722829340312868 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.6438e+05 | 99895 | 6.077e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 9499.662704840839 (tsim/hr) [sph::Model][rank=0]
---------------- t = 34.623800184584546, dt = 1.722829340312868 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99895 min = 99895 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99895 min = 99895 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99895
max = 99895
avg = 99895
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 5.86 us (1.6%)
patch tree reduce : 1362.00 ns (0.4%)
gen split merge : 731.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 992.00 ns (0.3%)
LB compute : 357.48 us (94.9%)
LB move op cnt : 0
LB apply : 3.32 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.32 us (71.2%)
central potential accretion : += 6.000000000000001e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.0101573689394757 unconverged cnt = 7
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.2335946425169457e-09,-1.0110833418412503e-09,2.006975167526294e-10)
sum a = (-1.4254036019984242e-11,-1.8173727540219454e-11,3.610406449957043e-12)
sum e = 1.2823481122100748e-10
sum de = 2.606783391355932e-16
Info: CFL hydro = 1.7422556794027244 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.7422556794027244 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.6494e+05 | 99889 | 6.056e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 10241.033787328493 (tsim/hr) [sph::Model][rank=0]
---------------- t = 36.346629524897416, dt = 1.7422556794027244 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99889 min = 99889 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99889 min = 99889 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99889
max = 99889
avg = 99889
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.90 us (1.8%)
patch tree reduce : 1322.00 ns (0.3%)
gen split merge : 1343.00 ns (0.3%)
split / merge op : 0/0
apply split merge : 982.00 ns (0.3%)
LB compute : 367.74 us (94.7%)
LB move op cnt : 0
LB apply : 3.26 us (0.8%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.25 us (70.5%)
central potential accretion : += 4e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.01015770148244071 unconverged cnt = 2
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.232251389519978e-09,-1.066406259919311e-09,1.9759545848894444e-10)
sum a = (-1.3564993350819335e-11,-1.7807678467061634e-11,3.3829973647790766e-12)
sum e = 1.2821627038962011e-10
sum de = 2.5602623288564937e-16
Info: CFL hydro = 1.7390461153807473 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.7390461153807473 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.6466e+05 | 99885 | 6.066e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 10339.51635228111 (tsim/hr) [sph::Model][rank=0]
---------------- t = 38.08888520430014, dt = 1.7390461153807473 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99885 min = 99885 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99885 min = 99885 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99885
max = 99885
avg = 99885
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.93 us (1.8%)
patch tree reduce : 1232.00 ns (0.3%)
gen split merge : 701.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1012.00 ns (0.3%)
LB compute : 362.90 us (94.7%)
LB move op cnt : 0
LB apply : 3.29 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.33 us (70.5%)
central potential accretion : += 6.000000000000001e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010158027587588775 unconverged cnt = 3
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.2594381368097217e-09,-1.1303530270455518e-09,2.0449809460755459e-10)
sum a = (-1.2679367020592377e-11,-1.8291043490710875e-11,3.286249135278068e-12)
sum e = 1.2818671363626677e-10
sum de = 2.467478707875772e-16
Info: CFL hydro = 1.6372168730939018 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.6372168730939018 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.6435e+05 | 99879 | 6.077e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 10301.801025391824 (tsim/hr) [sph::Model][rank=0]
---------------- t = 39.827931319680886, dt = 1.6372168730939018 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99879 min = 99879 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99879 min = 99879 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99879
max = 99879
avg = 99879
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.84 us (1.8%)
patch tree reduce : 1362.00 ns (0.4%)
gen split merge : 691.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 992.00 ns (0.3%)
LB compute : 357.91 us (93.4%)
LB move op cnt : 0
LB apply : 3.40 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.21 us (70.2%)
central potential accretion : += 1e-07
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010158329285089815 unconverged cnt = 6
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.2660902690916048e-09,-1.1908232828095592e-09,2.0443220007486986e-10)
sum a = (-1.1841387100566285e-11,-1.8309502626200677e-11,3.116802215476131e-12)
sum e = 1.281329034415003e-10
sum de = 1.8970097095974726e-16
Info: CFL hydro = 1.6055671475496687 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.6055671475496687 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.6519e+05 | 99869 | 6.046e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 9749.18138100756 (tsim/hr) [sph::Model][rank=0]
---------------- t = 41.46514819277479, dt = 1.6055671475496687 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99869 min = 99869 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99869 min = 99869 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99869
max = 99869
avg = 99869
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.70 us (2.0%)
patch tree reduce : 2.18 us (0.6%)
gen split merge : 831.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1022.00 ns (0.3%)
LB compute : 368.45 us (93.8%)
LB move op cnt : 0
LB apply : 4.91 us (1.2%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.31 us (69.8%)
central potential accretion : += 8e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010158620152524644 unconverged cnt = 1
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.289472159395978e-09,-1.265034723592563e-09,2.1176362558380807e-10)
sum a = (-1.0606859852281365e-11,-1.8819795187148415e-11,2.958645862124068e-12)
sum e = 1.2809183805722165e-10
sum de = 1.5537142547876754e-16
Info: CFL hydro = 1.535644174984961 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.535644174984961 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.6647e+05 | 99861 | 5.999e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 9635.229066321666 (tsim/hr) [sph::Model][rank=0]
---------------- t = 43.07071534032446, dt = 1.535644174984961 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99861 min = 99861 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99861 min = 99861 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99861
max = 99861
avg = 99861
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.65 us (1.9%)
patch tree reduce : 1503.00 ns (0.4%)
gen split merge : 662.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1082.00 ns (0.3%)
LB compute : 329.59 us (94.2%)
LB move op cnt : 0
LB apply : 3.72 us (1.1%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.25 us (71.2%)
central potential accretion : += 3.0000000000000004e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010158893728199529 unconverged cnt = 2
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.2968361410341873e-09,-1.3050079806387842e-09,2.1320997625145618e-10)
sum a = (-1.0283805900361317e-11,-1.8919518164686403e-11,2.95623400702929e-12)
sum e = 1.2807440937109975e-10
sum de = 1.630983013191241e-16
Info: CFL hydro = 1.4794258656418462 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.4794258656418462 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.4800e+05 | 99858 | 6.747e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 8193.557920882147 (tsim/hr) [sph::Model][rank=0]
---------------- t = 44.60635951530942, dt = 1.4794258656418462 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99858 min = 99858 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99858 min = 99858 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99858
max = 99858
avg = 99858
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.53 us (1.7%)
patch tree reduce : 1253.00 ns (0.3%)
gen split merge : 741.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 982.00 ns (0.3%)
LB compute : 372.72 us (95.0%)
LB move op cnt : 0
LB apply : 3.35 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.42 us (72.2%)
central potential accretion : += 7e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010159153018553743 unconverged cnt = 3
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.2672834684514459e-09,-1.3663338833635816e-09,2.008450658050698e-10)
sum a = (-9.34773858421953e-12,-1.8018480916089382e-11,2.676662462026388e-12)
sum e = 1.280377370056914e-10
sum de = 1.1764396504032613e-16
Info: CFL hydro = 1.7116874835106428 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.7116874835106428 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.7061e+05 | 99851 | 5.852e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 9100.370821035403 (tsim/hr) [sph::Model][rank=0]
---------------- t = 46.085785380951265, dt = 1.7116874835106428 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99851 min = 99851 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99851 min = 99851 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99851
max = 99851
avg = 99851
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.28 us (1.6%)
patch tree reduce : 1513.00 ns (0.4%)
gen split merge : 752.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1042.00 ns (0.3%)
LB compute : 365.96 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.58 us (71.6%)
central potential accretion : += 5e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010159447795937788 unconverged cnt = 2
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.2952646659763495e-09,-1.4005316966776006e-09,2.102109543807692e-10)
sum a = (-9.239426775791723e-12,-1.8831157335110845e-11,2.8471010156150225e-12)
sum e = 1.280215098802822e-10
sum de = 8.948794268687697e-17
Info: CFL hydro = 1.671980170913954 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.671980170913954 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.7090e+05 | 99846 | 5.842e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 10547.07605348816 (tsim/hr) [sph::Model][rank=0]
---------------- t = 47.79747286446191, dt = 1.671980170913954 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99846 min = 99846 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99846 min = 99846 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99846
max = 99846
avg = 99846
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 8.15 us (2.2%)
patch tree reduce : 1543.00 ns (0.4%)
gen split merge : 1082.00 ns (0.3%)
split / merge op : 0/0
apply split merge : 1282.00 ns (0.4%)
LB compute : 339.47 us (93.6%)
LB move op cnt : 0
LB apply : 3.66 us (1.0%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.18 us (68.5%)
central potential accretion : += 5e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010159730337799572 unconverged cnt = 5
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.309290977105502e-09,-1.4415421422224802e-09,2.1479676345317736e-10)
sum a = (-8.950536402619545e-12,-1.9285494607342044e-11,2.9309081753757575e-12)
sum e = 1.279947674706495e-10
sum de = 6.340622580218122e-17
Info: CFL hydro = 1.6389902526323896 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.6389902526323896 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.7091e+05 | 99841 | 5.842e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 10303.521027493423 (tsim/hr) [sph::Model][rank=0]
---------------- t = 49.469453035375864, dt = 0.04849122972642306 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99841 min = 99841 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99841 min = 99841 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99841
max = 99841
avg = 99841
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.72 us (1.6%)
patch tree reduce : 1603.00 ns (0.4%)
gen split merge : 922.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 991.00 ns (0.2%)
LB compute : 389.50 us (95.0%)
LB move op cnt : 0
LB apply : 3.35 us (0.8%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.40 us (72.1%)
central potential accretion : += 6.000000000000001e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010159738452633339 unconverged cnt = 4
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.317638874654658e-09,-1.450873514022683e-09,2.18261056683825e-10)
sum a = (-8.738372275187584e-12,-1.9540591394431388e-11,2.88905257821329e-12)
sum e = 1.2793068064729462e-10
sum de = 1.9714289390550583e-17
Info: CFL hydro = 1.7296865631034695 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.7296865631034695 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.7557e+05 | 99835 | 5.686e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 307.0043284678685 (tsim/hr) [sph::Model][rank=0]
Info: iteration since start : 36 [SPH][rank=0]
Info: time since start : 1363.922993627 (s) [SPH][rank=0]
Info: dump to _to_trash/black_hole_disc_lense_thirring_100000/dump/dump_0000002.vtk [VTK Dump][rank=0]
- took 7.68 ms, bandwidth = 694.04 MB/s
Info: Dumping state to _to_trash/black_hole_disc_lense_thirring_100000/dump/dump_0000002.sham [SPH][rank=0]
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.17 us (53.9%)
Info: dump to _to_trash/black_hole_disc_lense_thirring_100000/dump/dump_0000002.sham [Shamrock Dump][rank=0]
- took 11.63 ms, bandwidth = 982.57 MB/s
Info: compute_column_integ field_name: rho, center: (0,0,0), delta_x: (1.1845115302733742,0,0), delta_y: (0,1.1845115302733742,0), nx: 1024, ny: 1024 [sph::CartesianRender][rank=0]
Info: compute_column_integ took 628.26 ms [sph::CartesianRender][rank=0]
Info: compute_column_integ field_name: vxyz, center: (0,0,0), delta_x: (1.1845115302733742,0,0), delta_y: (0,1.1845115302733742,0), nx: 1024, ny: 1024 [sph::CartesianRender][rank=0]
Info: compute_column_integ took 632.97 ms [sph::CartesianRender][rank=0]
---------------- t = 49.51794426510229, dt = 1.7296865631034695 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99835 min = 99835 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99835 min = 99835 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99835
max = 99835
avg = 99835
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.88 us (1.4%)
patch tree reduce : 1192.00 ns (0.2%)
gen split merge : 861.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1071.00 ns (0.2%)
LB compute : 536.03 us (95.9%)
LB move op cnt : 0
LB apply : 3.62 us (0.6%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.75 us (72.9%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.3327536690845362e-09,-1.4846728624120212e-09,2.2325814417171978e-10)
sum a = (-8.650898777310962e-12,-2.0083108140243798e-11,3.064489752875755e-12)
sum e = 1.279667743929751e-10
sum de = 3.018725876890681e-17
Info: CFL hydro = 1.6601414229548692 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.6601414229548692 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 | 2.7409e+05 | 99835 | 3.642e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 17095.345179698634 (tsim/hr) [sph::Model][rank=0]
---------------- t = 51.24763082820576, dt = 1.6601414229548692 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99835 min = 99835 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99835 min = 99835 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99835
max = 99835
avg = 99835
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.72 us (1.9%)
patch tree reduce : 1463.00 ns (0.4%)
gen split merge : 751.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1072.00 ns (0.3%)
LB compute : 341.09 us (94.3%)
LB move op cnt : 0
LB apply : 3.35 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.29 us (70.4%)
central potential accretion : += 6.000000000000001e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010160294649794333 unconverged cnt = 2
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.3215303852701494e-09,-1.5390329227771239e-09,2.1900825178503403e-10)
sum a = (-7.966657302123056e-12,-1.9914890582652754e-11,3.0030574720101416e-12)
sum e = 1.279337311003196e-10
sum de = -1.101156145445266e-17
Info: CFL hydro = 1.6001500983597647 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.6001500983597647 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.7475e+05 | 99829 | 5.713e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 10461.863153783008 (tsim/hr) [sph::Model][rank=0]
---------------- t = 52.90777225116063, dt = 1.6001500983597647 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99829 min = 99829 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99829 min = 99829 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99829
max = 99829
avg = 99829
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.80 us (1.7%)
patch tree reduce : 1352.00 ns (0.3%)
gen split merge : 902.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 992.00 ns (0.3%)
LB compute : 372.03 us (94.7%)
LB move op cnt : 0
LB apply : 3.74 us (1.0%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.37 us (71.8%)
central potential accretion : += 9e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010160549625228981 unconverged cnt = 2
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.3114761026328841e-09,-1.5971342824125693e-09,2.1647849919385425e-10)
sum a = (-7.1146328283411884e-12,-1.9788177629760467e-11,2.9103308828310343e-12)
sum e = 1.27885712256783e-10
sum de = -9.791496339358455e-17
Info: CFL hydro = 1.6322284637882554 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.6322284637882554 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.7630e+05 | 99820 | 5.662e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 10174.021554520212 (tsim/hr) [sph::Model][rank=0]
---------------- t = 54.50792234952039, dt = 1.6322284637882554 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99820 min = 99820 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99820 min = 99820 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99820
max = 99820
avg = 99820
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.32 us (1.8%)
patch tree reduce : 1453.00 ns (0.4%)
gen split merge : 791.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 972.00 ns (0.3%)
LB compute : 340.53 us (94.5%)
LB move op cnt : 0
LB apply : 3.23 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.25 us (70.6%)
central potential accretion : += 4e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010160804723012328 unconverged cnt = 1
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.3240541077285229e-09,-1.632976332600365e-09,2.2198437587674938e-10)
sum a = (-6.899819568971093e-12,-2.0395841550811552e-11,3.0639409800717256e-12)
sum e = 1.2786635048951434e-10
sum de = -1.2907432186619028e-16
Info: CFL hydro = 1.7464194613218378 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.7464194613218378 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.7694e+05 | 99816 | 5.641e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 10416.015503576597 (tsim/hr) [sph::Model][rank=0]
---------------- t = 56.14015081330865, dt = 1.7464194613218378 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99816 min = 99816 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99816 min = 99816 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99816
max = 99816
avg = 99816
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.95 us (1.8%)
patch tree reduce : 1483.00 ns (0.4%)
gen split merge : 1122.00 ns (0.3%)
split / merge op : 0/0
apply split merge : 1111.00 ns (0.3%)
LB compute : 358.71 us (94.4%)
LB move op cnt : 0
LB apply : 3.56 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.38 us (72.1%)
central potential accretion : += 3.0000000000000004e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.01016107210188294 unconverged cnt = 2
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.3284664272262877e-09,-1.6813645898170221e-09,2.2513395995312738e-10)
sum a = (-6.381804330290491e-12,-2.082140071115108e-11,3.134755539649454e-12)
sum e = 1.2785549865469098e-10
sum de = -1.4802522038944503e-16
Info: CFL hydro = 1.6831231613647732 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.6831231613647732 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.7818e+05 | 99813 | 5.602e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 11223.22619829266 (tsim/hr) [sph::Model][rank=0]
---------------- t = 57.886570274630486, dt = 1.6831231613647732 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99813 min = 99813 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99813 min = 99813 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99813
max = 99813
avg = 99813
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.06 us (1.7%)
patch tree reduce : 1453.00 ns (0.4%)
gen split merge : 741.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 972.00 ns (0.3%)
LB compute : 326.96 us (94.3%)
LB move op cnt : 0
LB apply : 3.74 us (1.1%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.38 us (72.0%)
central potential accretion : += 9e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.01016132435992146 unconverged cnt = 3
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.31328517118176e-09,-1.7359653901290272e-09,2.2021187961985724e-10)
sum a = (-5.686192642271315e-12,-2.0752283519574366e-11,3.082514645176917e-12)
sum e = 1.2780721893051334e-10
sum de = -2.1643597976488524e-16
Info: CFL hydro = 1.6297705816607704 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.6297705816607704 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.7761e+05 | 99804 | 5.619e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 10782.778468092996 (tsim/hr) [sph::Model][rank=0]
---------------- t = 59.56969343599526, dt = 1.6297705816607704 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99804 min = 99804 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99804 min = 99804 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99804
max = 99804
avg = 99804
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.62 us (2.0%)
patch tree reduce : 1773.00 ns (0.5%)
gen split merge : 922.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1292.00 ns (0.3%)
LB compute : 343.65 us (89.0%)
LB move op cnt : 0
LB apply : 3.88 us (1.0%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.44 us (71.3%)
central potential accretion : += 7e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010161563557136372 unconverged cnt = 6
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010161563557136374 unconverged cnt = 1
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.334867844052991e-09,-1.7601721589228814e-09,2.2991666755154166e-10)
sum a = (-5.739870672509433e-12,-2.1803874668712552e-11,3.3531744430764673e-12)
sum e = 1.2776908454393872e-10
sum de = -2.6267795165230475e-16
Info: CFL hydro = 1.5171893166476595 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.5171893166476595 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.3176e+05 | 99797 | 7.574e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 7746.483706733078 (tsim/hr) [sph::Model][rank=0]
---------------- t = 61.199464017656034, dt = 1.5171893166476595 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99797 min = 99797 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99797 min = 99797 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99797
max = 99797
avg = 99797
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.68 us (1.7%)
patch tree reduce : 1453.00 ns (0.4%)
gen split merge : 751.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 971.00 ns (0.2%)
LB compute : 369.76 us (94.8%)
LB move op cnt : 0
LB apply : 3.47 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.31 us (72.4%)
central potential accretion : += 4e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.3122881322433725e-09,-1.8157007276039266e-09,2.2413616338744874e-10)
sum a = (-4.861766821965835e-12,-2.1543441403131486e-11,3.2457315544018718e-12)
sum e = 1.2774424388956543e-10
sum de = -3.0283938677094774e-16
Info: CFL hydro = 1.4953919954449297 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.4953919954449297 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 | 2.8197e+05 | 99793 | 3.539e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 15432.8115095137 (tsim/hr) [sph::Model][rank=0]
---------------- t = 62.71665333430369, dt = 1.4953919954449297 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99793 min = 99793 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99793 min = 99793 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99793
max = 99793
avg = 99793
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.69 us (1.7%)
patch tree reduce : 1543.00 ns (0.4%)
gen split merge : 772.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 961.00 ns (0.2%)
LB compute : 377.10 us (94.9%)
LB move op cnt : 0
LB apply : 3.29 us (0.8%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.40 us (70.6%)
central potential accretion : += 1e-07
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010161992636965034 unconverged cnt = 2
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010161992636965034 unconverged cnt = 1
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.2533684503107762e-09,-1.8652279573266588e-09,2.0422371821171174e-10)
sum a = (-4.05923443956232e-12,-2.0232396571327776e-11,3.126841952389499e-12)
sum e = 1.2769224214609986e-10
sum de = -4.2635071950005874e-16
Info: CFL hydro = 1.5926196327781077 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.5926196327781077 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.3271e+05 | 99783 | 7.519e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 7159.621812311816 (tsim/hr) [sph::Model][rank=0]
---------------- t = 64.21204532974862, dt = 1.5926196327781077 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99783 min = 99783 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99783 min = 99783 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99783
max = 99783
avg = 99783
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.70 us (2.0%)
patch tree reduce : 1693.00 ns (0.4%)
gen split merge : 1132.00 ns (0.3%)
split / merge op : 0/0
apply split merge : 1463.00 ns (0.4%)
LB compute : 359.38 us (94.1%)
LB move op cnt : 0
LB apply : 3.35 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.96 us (69.0%)
central potential accretion : += 2e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.2781172974944355e-09,-1.90222484937217e-09,2.1681742568000258e-10)
sum a = (-3.723479692058582e-12,-2.144498913064369e-11,3.261675549740737e-12)
sum e = 1.276847358613284e-10
sum de = -4.268191800402878e-16
Info: CFL hydro = 1.6291755343148668 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.6291755343148668 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 | 2.8220e+05 | 99781 | 3.536e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 16215.472290754977 (tsim/hr) [sph::Model][rank=0]
---------------- t = 65.80466496252673, dt = 1.6291755343148668 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99781 min = 99781 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99781 min = 99781 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99781
max = 99781
avg = 99781
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.52 us (1.7%)
patch tree reduce : 1704.00 ns (0.4%)
gen split merge : 851.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1232.00 ns (0.3%)
LB compute : 371.00 us (94.6%)
LB move op cnt : 0
LB apply : 3.81 us (1.0%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.64 us (71.1%)
central potential accretion : += 4e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.2759980523814999e-09,-1.9382832285592827e-09,2.18834723549254e-10)
sum a = (-3.3951279636221884e-12,-2.1937500954249735e-11,3.3761799566649216e-12)
sum e = 1.2766518030614176e-10
sum de = -4.403864759483346e-16
Info: CFL hydro = 1.7909872014143011 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.7909872014143011 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 | 2.8422e+05 | 99777 | 3.511e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 16706.768171291722 (tsim/hr) [sph::Model][rank=0]
---------------- t = 67.4338404968416, dt = 1.7909872014143011 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99777 min = 99777 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99777 min = 99777 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99777
max = 99777
avg = 99777
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 8.90 us (2.4%)
patch tree reduce : 1723.00 ns (0.5%)
gen split merge : 862.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1343.00 ns (0.4%)
LB compute : 347.49 us (93.2%)
LB move op cnt : 0
LB apply : 3.83 us (1.0%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.26 us (72.2%)
central potential accretion : += 4e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.2745114403040908e-09,-1.9987273317041725e-09,2.225439282658665e-10)
sum a = (-2.4801199084299795e-12,-2.2552802420660827e-11,3.2559899526433333e-12)
sum e = 1.2765075702347222e-10
sum de = -4.607341511678574e-16
Info: CFL hydro = 1.7250261415556836 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.7250261415556836 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 | 2.7881e+05 | 99773 | 3.579e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 18017.350414086202 (tsim/hr) [sph::Model][rank=0]
---------------- t = 69.2248276982559, dt = 1.7250261415556836 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99773 min = 99773 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99773 min = 99773 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99773
max = 99773
avg = 99773
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.79 us (1.8%)
patch tree reduce : 1483.00 ns (0.4%)
gen split merge : 842.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1132.00 ns (0.3%)
LB compute : 355.43 us (94.5%)
LB move op cnt : 0
LB apply : 3.34 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.69 us (69.5%)
central potential accretion : += 3.0000000000000004e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010162891352853146 unconverged cnt = 1
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.269651520246512e-09,-2.0405723448196905e-09,2.2501479178789247e-10)
sum a = (-1.9660378416531365e-12,-2.3056791975795017e-11,3.300893263389318e-12)
sum e = 1.2763178603519968e-10
sum de = -4.756214645619708e-16
Info: CFL hydro = 1.6637369303042768 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.6637369303042768 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.8334e+05 | 99770 | 5.442e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 11411.955486543968 (tsim/hr) [sph::Model][rank=0]
---------------- t = 70.94985383981158, dt = 1.6637369303042768 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99770 min = 99770 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99770 min = 99770 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99770
max = 99770
avg = 99770
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.16 us (2.0%)
patch tree reduce : 1333.00 ns (0.4%)
gen split merge : 1092.00 ns (0.3%)
split / merge op : 0/0
apply split merge : 982.00 ns (0.3%)
LB compute : 335.63 us (94.1%)
LB move op cnt : 0
LB apply : 3.56 us (1.0%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.56 us (70.3%)
central potential accretion : += 7e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010163100385772618 unconverged cnt = 4
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.01016310038577262 unconverged cnt = 1
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.2509702155190983e-09,-2.0992159586211978e-09,2.2279284551319533e-10)
sum a = (-9.689911480298294e-13,-2.3184062272969218e-11,3.095358229472117e-12)
sum e = 1.275928471018019e-10
sum de = -5.487752788562033e-16
Info: CFL hydro = 1.611568637909217 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.611568637909217 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.3514e+05 | 99763 | 7.382e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 8113.204133420567 (tsim/hr) [sph::Model][rank=0]
---------------- t = 72.61359077011586, dt = 1.611568637909217 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99763 min = 99763 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99763 min = 99763 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99763
max = 99763
avg = 99763
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.79 us (1.8%)
patch tree reduce : 1553.00 ns (0.4%)
gen split merge : 821.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1092.00 ns (0.3%)
LB compute : 348.86 us (94.4%)
LB move op cnt : 0
LB apply : 3.48 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.54 us (71.5%)
central potential accretion : += 3.0000000000000004e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010163298023844577 unconverged cnt = 1
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.2250642737465445e-09,-2.1313442479580396e-09,2.1738718773050992e-10)
sum a = (-5.910370084845406e-13,-2.3086713070174133e-11,3.16853282430011e-12)
sum e = 1.2757453104758433e-10
sum de = -5.684671745804506e-16
Info: CFL hydro = 1.5662474152117345 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.5662474152117345 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.8435e+05 | 99760 | 5.411e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 10721.33288384004 (tsim/hr) [sph::Model][rank=0]
---------------- t = 74.22515940802508, dt = 0.05175698962834474 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99760 min = 99760 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99760 min = 99760 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99760
max = 99760
avg = 99760
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.96 us (2.0%)
patch tree reduce : 1362.00 ns (0.4%)
gen split merge : 972.00 ns (0.3%)
split / merge op : 0/0
apply split merge : 972.00 ns (0.3%)
LB compute : 330.68 us (94.2%)
LB move op cnt : 0
LB apply : 3.34 us (1.0%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.35 us (69.5%)
central potential accretion : += 6.000000000000001e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010163304292339545 unconverged cnt = 1
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.227069385606949e-09,-2.1186820053546145e-09,2.1803294734311713e-10)
sum a = (-9.197402668259293e-13,-2.3201406512359195e-11,3.331464262776079e-12)
sum e = 1.2751346589452817e-10
sum de = -6.282947846522582e-16
Info: CFL hydro = 1.5679589297010375 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.5679589297010375 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.8434e+05 | 99754 | 5.411e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 344.32225890129007 (tsim/hr) [sph::Model][rank=0]
Info: iteration since start : 52 [SPH][rank=0]
Info: time since start : 1373.8216806100002 (s) [SPH][rank=0]
Info: dump to _to_trash/black_hole_disc_lense_thirring_100000/dump/dump_0000003.vtk [VTK Dump][rank=0]
- took 8.54 ms, bandwidth = 623.88 MB/s
Info: Dumping state to _to_trash/black_hole_disc_lense_thirring_100000/dump/dump_0000003.sham [SPH][rank=0]
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.70 us (56.5%)
Info: dump to _to_trash/black_hole_disc_lense_thirring_100000/dump/dump_0000003.sham [Shamrock Dump][rank=0]
- took 12.47 ms, bandwidth = 916.19 MB/s
Info: compute_column_integ field_name: rho, center: (0,0,0), delta_x: (1.1845115302733742,0,0), delta_y: (0,1.1845115302733742,0), nx: 1024, ny: 1024 [sph::CartesianRender][rank=0]
Info: compute_column_integ took 627.15 ms [sph::CartesianRender][rank=0]
Info: compute_column_integ field_name: vxyz, center: (0,0,0), delta_x: (1.1845115302733742,0,0), delta_y: (0,1.1845115302733742,0), nx: 1024, ny: 1024 [sph::CartesianRender][rank=0]
Info: compute_column_integ took 669.68 ms [sph::CartesianRender][rank=0]
---------------- t = 74.27691639765342, dt = 1.5679589297010375 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99754 min = 99754 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99754 min = 99754 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99754
max = 99754
avg = 99754
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.47 us (1.5%)
patch tree reduce : 1493.00 ns (0.3%)
gen split merge : 691.00 ns (0.1%)
split / merge op : 0/0
apply split merge : 1002.00 ns (0.2%)
LB compute : 481.32 us (95.6%)
LB move op cnt : 0
LB apply : 3.55 us (0.7%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.63 us (73.5%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.228511060507127e-09,-2.1550613879347124e-09,2.2325640711869818e-10)
sum a = (-4.2496285379128906e-13,-2.3916615646009622e-11,3.3472295925609485e-12)
sum e = 1.275413575426712e-10
sum de = -6.093753254393909e-16
Info: CFL hydro = 1.5252347971853921 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.5252347971853921 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 | 2.6588e+05 | 99754 | 3.752e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 15044.844066143562 (tsim/hr) [sph::Model][rank=0]
---------------- t = 75.84487532735446, dt = 1.5252347971853921 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99754 min = 99754 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99754 min = 99754 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99754
max = 99754
avg = 99754
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 8.44 us (2.0%)
patch tree reduce : 1803.00 ns (0.4%)
gen split merge : 841.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1322.00 ns (0.3%)
LB compute : 391.46 us (93.9%)
LB move op cnt : 0
LB apply : 4.96 us (1.2%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.38 us (71.7%)
central potential accretion : += 1e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.2198465524516858e-09,-2.1955356696881856e-09,2.251108615297505e-10)
sum a = (2.0594141054740733e-13,-2.434628133597451e-11,3.2706586589835144e-12)
sum e = 1.2753380539078087e-10
sum de = -5.981070878093184e-16
Info: CFL hydro = 1.6949939527267186 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.6949939527267186 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 | 2.8666e+05 | 99753 | 3.480e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 15778.840362923127 (tsim/hr) [sph::Model][rank=0]
---------------- t = 77.37011012453985, dt = 1.6949939527267186 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99753 min = 99753 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99753 min = 99753 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99753
max = 99753
avg = 99753
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.78 us (1.8%)
patch tree reduce : 1514.00 ns (0.4%)
gen split merge : 842.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1062.00 ns (0.3%)
LB compute : 356.89 us (94.6%)
LB move op cnt : 0
LB apply : 3.57 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.69 us (69.6%)
central potential accretion : += 4e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010163863074067993 unconverged cnt = 2
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.205421112778787e-09,-2.2293639594088005e-09,2.2521433303986243e-10)
sum a = (6.784875520699684e-13,-2.473173268838586e-11,3.2900943206823933e-12)
sum e = 1.2751877385281577e-10
sum de = -6.177166762864948e-16
Info: CFL hydro = 1.7279895918722334 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.7279895918722334 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.8222e+05 | 99749 | 5.474e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 11147.155753632616 (tsim/hr) [sph::Model][rank=0]
---------------- t = 79.06510407726657, dt = 1.7279895918722334 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99749 min = 99749 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99749 min = 99749 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99749
max = 99749
avg = 99749
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.47 us (1.9%)
patch tree reduce : 1363.00 ns (0.4%)
gen split merge : 1062.00 ns (0.3%)
split / merge op : 0/0
apply split merge : 1072.00 ns (0.3%)
LB compute : 325.59 us (94.2%)
LB move op cnt : 0
LB apply : 3.41 us (1.0%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.27 us (71.1%)
central potential accretion : += 5e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010164054497139054 unconverged cnt = 1
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.1941044447166914e-09,-2.2660528062674364e-09,2.2755658024550517e-10)
sum a = (1.2270218477867858e-12,-2.5232130750814673e-11,3.2592181940958458e-12)
sum e = 1.2749335857899823e-10
sum de = -6.613701273676363e-16
Info: CFL hydro = 1.7562461974516244 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.7562461974516244 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.8580e+05 | 99744 | 5.368e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 11588.136970361249 (tsim/hr) [sph::Model][rank=0]
---------------- t = 80.7930936691388, dt = 1.7562461974516244 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99744 min = 99744 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99744 min = 99744 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99744
max = 99744
avg = 99744
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.38 us (1.7%)
patch tree reduce : 1323.00 ns (0.4%)
gen split merge : 731.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1011.00 ns (0.3%)
LB compute : 354.53 us (94.7%)
LB move op cnt : 0
LB apply : 3.45 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.91 us (70.4%)
central potential accretion : += 6.000000000000001e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010164243510154955 unconverged cnt = 1
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.1415465427952864e-09,-2.2994583815535648e-09,2.1466306380406575e-10)
sum a = (1.8081926669582542e-12,-2.4554935536620637e-11,3.2229932028969077e-12)
sum e = 1.2746249415565057e-10
sum de = -7.097483335653359e-16
Info: CFL hydro = 1.7126679143212145 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.7126679143212145 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.8551e+05 | 99738 | 5.376e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 11759.750138900848 (tsim/hr) [sph::Model][rank=0]
---------------- t = 82.54933986659043, dt = 1.7126679143212145 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99738 min = 99738 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99738 min = 99738 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99738
max = 99738
avg = 99738
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.65 us (1.9%)
patch tree reduce : 1343.00 ns (0.4%)
gen split merge : 721.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1233.00 ns (0.4%)
LB compute : 330.03 us (94.3%)
LB move op cnt : 0
LB apply : 3.25 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.37 us (70.9%)
central potential accretion : += 2e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010164422466642786 unconverged cnt = 1
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.1211433527048138e-09,-2.3326646520969437e-09,2.1397516067903897e-10)
sum a = (2.3500564238874515e-12,-2.4821946410183654e-11,3.1673490569010653e-12)
sum e = 1.2744912690351083e-10
sum de = -7.022022539647405e-16
Info: CFL hydro = 1.676277716866935 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.676277716866935 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.8632e+05 | 99736 | 5.353e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 11517.900604696948 (tsim/hr) [sph::Model][rank=0]
---------------- t = 84.26200778091165, dt = 1.676277716866935 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99736 min = 99736 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99736 min = 99736 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99736
max = 99736
avg = 99736
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.06 us (1.8%)
patch tree reduce : 1433.00 ns (0.4%)
gen split merge : 741.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1022.00 ns (0.3%)
LB compute : 368.88 us (94.5%)
LB move op cnt : 0
LB apply : 3.84 us (1.0%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.33 us (71.7%)
central potential accretion : += 6.000000000000001e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010164592501874216 unconverged cnt = 3
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.0849164639288037e-09,-2.3790720663757785e-09,2.0696521136312344e-10)
sum a = (3.2598646548206047e-12,-2.4604130415600705e-11,2.8612192901430398e-12)
sum e = 1.274157666807491e-10
sum de = -7.396390556208263e-16
Info: CFL hydro = 1.6453273876945742 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.6453273876945742 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.8692e+05 | 99730 | 5.335e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 11310.563977399766 (tsim/hr) [sph::Model][rank=0]
---------------- t = 85.93828549777858, dt = 1.6453273876945742 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99730 min = 99730 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99730 min = 99730 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99730
max = 99730
avg = 99730
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.40 us (1.6%)
patch tree reduce : 1884.00 ns (0.5%)
gen split merge : 781.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1002.00 ns (0.2%)
LB compute : 386.90 us (95.0%)
LB move op cnt : 0
LB apply : 3.74 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.44 us (73.0%)
central potential accretion : += 7e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.0101647544852953 unconverged cnt = 4
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.0692526620581706e-09,-2.437267628126746e-09,2.0777933603629814e-10)
sum a = (4.431987784551845e-12,-2.4945992485943466e-11,2.3413984588075332e-12)
sum e = 1.2737726535248094e-10
sum de = -7.869160113174743e-16
Info: CFL hydro = 1.5591006264424292 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.5591006264424292 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.8667e+05 | 99723 | 5.342e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 11087.389812559497 (tsim/hr) [sph::Model][rank=0]
---------------- t = 87.58361288547316, dt = 1.5591006264424292 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99723 min = 99723 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99723 min = 99723 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99723
max = 99723
avg = 99723
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.63 us (1.9%)
patch tree reduce : 1393.00 ns (0.4%)
gen split merge : 812.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1152.00 ns (0.3%)
LB compute : 324.83 us (94.2%)
LB move op cnt : 0
LB apply : 3.59 us (1.0%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.43 us (70.0%)
central potential accretion : += 8e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.01016490349913205 unconverged cnt = 6
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.0123824335457836e-09,-2.4562210756503447e-09,1.941451999350681e-10)
sum a = (4.817263574364187e-12,-2.409092754761101e-11,2.3178360015118186e-12)
sum e = 1.2733136412587678e-10
sum de = -8.620065103118461e-16
Info: CFL hydro = 1.556978720252109 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.556978720252109 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.8717e+05 | 99715 | 5.328e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 10535.298013433041 (tsim/hr) [sph::Model][rank=0]
---------------- t = 89.14271351191559, dt = 1.556978720252109 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99715 min = 99715 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99715 min = 99715 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99715
max = 99715
avg = 99715
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.20 us (1.5%)
patch tree reduce : 1272.00 ns (0.3%)
gen split merge : 791.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 972.00 ns (0.2%)
LB compute : 389.12 us (95.2%)
LB move op cnt : 0
LB apply : 3.60 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.60 us (73.0%)
central potential accretion : += 2e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010165047968802266 unconverged cnt = 1
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.0045401300258286e-09,-2.496429540015026e-09,1.9763851758010592e-10)
sum a = (5.613223752974262e-12,-2.4654065322254013e-11,1.9927178928674268e-12)
sum e = 1.273197355816272e-10
sum de = -8.503568157695372e-16
Info: CFL hydro = 1.5781729804768112 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.5781729804768112 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.8652e+05 | 99713 | 5.346e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 10484.553213813577 (tsim/hr) [sph::Model][rank=0]
---------------- t = 90.69969223216769, dt = 1.5781729804768112 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99713 min = 99713 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99713 min = 99713 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99713
max = 99713
avg = 99713
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.87 us (1.9%)
patch tree reduce : 1442.00 ns (0.4%)
gen split merge : 852.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 972.00 ns (0.3%)
LB compute : 334.66 us (94.1%)
LB move op cnt : 0
LB apply : 3.60 us (1.0%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.62 us (72.1%)
central potential accretion : += 7e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.01016518998770623 unconverged cnt = 5
Info: conservation infos : [sph::Model][rank=0]
sum v = (-9.901387755822775e-10,-2.5272053503769625e-09,1.995598325575042e-10)
sum a = (6.229443178648054e-12,-2.5064878865046602e-11,1.760730567433604e-12)
sum e = 1.2728325475147932e-10
sum de = -9.009821225127252e-16
Info: CFL hydro = 1.6474576898161442 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.6474576898161442 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.8586e+05 | 99706 | 5.365e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 10590.627878962929 (tsim/hr) [sph::Model][rank=0]
---------------- t = 92.2778652126445, dt = 1.6474576898161442 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99706 min = 99706 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99706 min = 99706 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99706
max = 99706
avg = 99706
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.86 us (2.2%)
patch tree reduce : 1372.00 ns (0.4%)
gen split merge : 791.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1292.00 ns (0.4%)
LB compute : 340.11 us (93.9%)
LB move op cnt : 0
LB apply : 3.63 us (1.0%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.23 us (69.7%)
central potential accretion : += 5e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010165333508396207 unconverged cnt = 2
Info: conservation infos : [sph::Model][rank=0]
sum v = (-9.745339926769061e-10,-2.5638488421625043e-09,2.0072538417249504e-10)
sum a = (7.004024937776086e-12,-2.545401774685758e-11,1.4175977196428623e-12)
sum e = 1.2725861818460125e-10
sum de = -9.166876169376855e-16
Info: CFL hydro = 1.6794789178401577 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.6794789178401577 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.8774e+05 | 99701 | 5.311e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 11167.834713598011 (tsim/hr) [sph::Model][rank=0]
---------------- t = 93.92532290246065, dt = 1.6794789178401577 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99701 min = 99701 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99701 min = 99701 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99701
max = 99701
avg = 99701
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.08 us (1.9%)
patch tree reduce : 1432.00 ns (0.4%)
gen split merge : 1062.00 ns (0.3%)
split / merge op : 0/0
apply split merge : 992.00 ns (0.3%)
LB compute : 361.79 us (94.5%)
LB move op cnt : 0
LB apply : 3.33 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.40 us (72.7%)
central potential accretion : += 2e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-9.619270764426205e-10,-2.6066032956757023e-09,2.0276570116732275e-10)
sum a = (7.911078183067006e-12,-2.592001883063757e-11,9.578513441427957e-13)
sum e = 1.2724821916145365e-10
sum de = -8.969220031710045e-16
Info: CFL hydro = 1.6267840537744158 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.6267840537744158 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 | 2.8530e+05 | 99699 | 3.495e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 17301.52508818608 (tsim/hr) [sph::Model][rank=0]
---------------- t = 95.6048018203008, dt = 1.6267840537744158 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99699 min = 99699 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99699 min = 99699 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99699
max = 99699
avg = 99699
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.85 us (1.7%)
patch tree reduce : 1673.00 ns (0.4%)
gen split merge : 781.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1021.00 ns (0.3%)
LB compute : 378.69 us (94.7%)
LB move op cnt : 0
LB apply : 3.82 us (1.0%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.43 us (71.3%)
central potential accretion : += 9e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010165606999974307 unconverged cnt = 4
Info: conservation infos : [sph::Model][rank=0]
sum v = (-9.020802608464987e-10,-2.652824440584454e-09,1.8487777960991548e-10)
sum a = (8.97773966084038e-12,-2.4911715566506978e-11,3.1638297058739827e-13)
sum e = 1.2719822260079522e-10
sum de = -9.586553816111809e-16
Info: CFL hydro = 1.642237190627325 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.642237190627325 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.8817e+05 | 99690 | 5.298e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 11054.11393453757 (tsim/hr) [sph::Model][rank=0]
---------------- t = 97.23158587407522, dt = 1.642237190627325 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99690 min = 99690 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99690 min = 99690 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99690
max = 99690
avg = 99690
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.76 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 : 1272.00 ns (0.3%)
LB compute : 358.20 us (94.4%)
LB move op cnt : 0
LB apply : 4.04 us (1.1%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.23 us (69.5%)
central potential accretion : += 2e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010165735656869257 unconverged cnt = 3
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010165735656869257 unconverged cnt = 1
Info: conservation infos : [sph::Model][rank=0]
sum v = (-8.679373303257125e-10,-2.6895994359877475e-09,1.7817257710627275e-10)
sum a = (9.805561327209855e-12,-2.4691045502426056e-11,-1.6908506975877442e-13)
sum e = 1.2718686218297345e-10
sum de = -9.395516014360118e-16
Info: CFL hydro = 1.5804395465482817 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.5804395465482817 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.3936e+05 | 99688 | 7.153e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 8264.942378105177 (tsim/hr) [sph::Model][rank=0]
---------------- t = 98.87382306470255, dt = 0.1620654655020246 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99688 min = 99688 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99688 min = 99688 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99688
max = 99688
avg = 99688
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.98 us (1.9%)
patch tree reduce : 1253.00 ns (0.3%)
gen split merge : 671.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1062.00 ns (0.3%)
LB compute : 345.63 us (94.6%)
LB move op cnt : 0
LB apply : 3.36 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 21.37 us (95.1%)
central potential accretion : += 9e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010165748095554403 unconverged cnt = 10
Info: conservation infos : [sph::Model][rank=0]
sum v = (-7.961253639332071e-10,-2.6424868126629294e-09,1.56189151674274e-10)
sum a = (8.861734670536405e-12,-2.2807997227160482e-11,4.828444731972865e-13)
sum e = 1.271087927012866e-10
sum de = -1.034272449062682e-15
Info: CFL hydro = 1.577336296666391 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.577336296666391 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.8797e+05 | 99679 | 5.303e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 1100.1944104306922 (tsim/hr) [sph::Model][rank=0]
Info: iteration since start : 68 [SPH][rank=0]
Info: time since start : 1383.4842188940002 (s) [SPH][rank=0]
Info: dump to _to_trash/black_hole_disc_lense_thirring_100000/dump/dump_0000004.vtk [VTK Dump][rank=0]
- took 7.67 ms, bandwidth = 694.02 MB/s
Info: Dumping state to _to_trash/black_hole_disc_lense_thirring_100000/dump/dump_0000004.sham [SPH][rank=0]
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.38 us (53.8%)
Info: dump to _to_trash/black_hole_disc_lense_thirring_100000/dump/dump_0000004.sham [Shamrock Dump][rank=0]
- took 11.05 ms, bandwidth = 1.01 GB/s
Info: compute_column_integ field_name: rho, center: (0,0,0), delta_x: (1.1845115302733742,0,0), delta_y: (0,1.1845115302733742,0), nx: 1024, ny: 1024 [sph::CartesianRender][rank=0]
Info: compute_column_integ took 647.08 ms [sph::CartesianRender][rank=0]
Info: compute_column_integ field_name: vxyz, center: (0,0,0), delta_x: (1.1845115302733742,0,0), delta_y: (0,1.1845115302733742,0), nx: 1024, ny: 1024 [sph::CartesianRender][rank=0]
Info: compute_column_integ took 629.83 ms [sph::CartesianRender][rank=0]
---------------- t = 99.03588853020457, dt = 1.577336296666391 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99679 min = 99679 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99679 min = 99679 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99679
max = 99679
avg = 99679
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.81 us (1.5%)
patch tree reduce : 1523.00 ns (0.3%)
gen split merge : 811.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1252.00 ns (0.3%)
LB compute : 446.36 us (95.6%)
LB move op cnt : 0
LB apply : 3.32 us (0.7%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.48 us (72.5%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-7.821378703818e-10,-2.6784662514842306e-09,1.5694596096998818e-10)
sum a = (9.681290943868381e-12,-2.312340088693033e-11,-5.5503639497394895e-15)
sum e = 1.2713546688246845e-10
sum de = -9.857517842524846e-16
Info: CFL hydro = 1.7093949334213094 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.7093949334213094 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 | 2.8691e+05 | 99679 | 3.474e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 16344.343480565694 (tsim/hr) [sph::Model][rank=0]
---------------- t = 100.61322482687096, dt = 1.7093949334213094 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99679 min = 99679 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99679 min = 99679 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99679
max = 99679
avg = 99679
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.83 us (2.0%)
patch tree reduce : 1413.00 ns (0.4%)
gen split merge : 922.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1282.00 ns (0.3%)
LB compute : 371.89 us (94.0%)
LB move op cnt : 0
LB apply : 3.82 us (1.0%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.41 us (71.5%)
central potential accretion : += 5e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010165990389981954 unconverged cnt = 1
Info: conservation infos : [sph::Model][rank=0]
sum v = (-7.222650812717397e-10,-2.6977000483454017e-09,1.4216929675030844e-10)
sum a = (1.01931745445133e-11,-2.2181543845500844e-11,-3.3159841978298336e-13)
sum e = 1.2711255985875358e-10
sum de = -9.999403929184286e-16
Info: CFL hydro = 1.708491729553777 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.708491729553777 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.8813e+05 | 99674 | 5.298e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 11614.833083156815 (tsim/hr) [sph::Model][rank=0]
---------------- t = 102.32261976029227, dt = 1.708491729553777 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99674 min = 99674 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99674 min = 99674 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99674
max = 99674
avg = 99674
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.33 us (1.8%)
patch tree reduce : 1302.00 ns (0.3%)
gen split merge : 842.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1032.00 ns (0.3%)
LB compute : 378.56 us (94.6%)
LB move op cnt : 0
LB apply : 3.54 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 8.06 us (72.9%)
central potential accretion : += 8e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010166108858591616 unconverged cnt = 4
Info: conservation infos : [sph::Model][rank=0]
sum v = (-6.6206148011661e-10,-2.708256732438394e-09,1.270665677433699e-10)
sum a = (1.0561213399236155e-11,-2.1244057225194944e-11,-5.615339401531909e-13)
sum e = 1.2706960668874472e-10
sum de = -1.0267697847770773e-15
Info: CFL hydro = 1.6244166363474222 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.6244166363474222 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.8863e+05 | 99666 | 5.284e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 11640.730057435803 (tsim/hr) [sph::Model][rank=0]
---------------- t = 104.03111148984604, dt = 1.6244166363474222 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99666 min = 99666 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99666 min = 99666 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99666
max = 99666
avg = 99666
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.45 us (1.6%)
patch tree reduce : 1363.00 ns (0.3%)
gen split merge : 691.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 991.00 ns (0.2%)
LB compute : 395.35 us (95.1%)
LB move op cnt : 0
LB apply : 3.35 us (0.8%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.58 us (72.7%)
central potential accretion : += 4e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010166216772449709 unconverged cnt = 2
Info: conservation infos : [sph::Model][rank=0]
sum v = (-6.084837874662416e-10,-2.7313405189564683e-09,1.1243684974327264e-10)
sum a = (1.117077437758373e-11,-2.0382330675748706e-11,-1.0224813680260082e-12)
sum e = 1.2704387537693566e-10
sum de = -1.0186204063597013e-15
Info: CFL hydro = 1.5551395219198003 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.5551395219198003 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.8414e+05 | 99662 | 5.412e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 10804.806781741096 (tsim/hr) [sph::Model][rank=0]
---------------- t = 105.65552812619346, dt = 1.5551395219198003 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99662 min = 99662 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99662 min = 99662 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99662
max = 99662
avg = 99662
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.81 us (1.9%)
patch tree reduce : 1333.00 ns (0.4%)
gen split merge : 972.00 ns (0.3%)
split / merge op : 0/0
apply split merge : 1022.00 ns (0.3%)
LB compute : 339.51 us (94.1%)
LB move op cnt : 0
LB apply : 3.87 us (1.1%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.27 us (71.2%)
central potential accretion : += 7e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010166315782916891 unconverged cnt = 1
Info: conservation infos : [sph::Model][rank=0]
sum v = (-5.629353077022541e-10,-2.7598686691291806e-09,9.904591935652655e-11)
sum a = (1.1887303021960627e-11,-1.9672460451540674e-11,-1.6157462631487036e-12)
sum e = 1.2700363127123398e-10
sum de = -1.0414640841317915e-15
Info: CFL hydro = 1.6119943786165212 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.6119943786165212 cfl multiplier : 0.9999999999997925 [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.8880e+05 | 99655 | 5.278e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 10606.706106315032 (tsim/hr) [sph::Model][rank=0]
---------------- t = 107.21066764811326, dt = 1.6119943786165212 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99655 min = 99655 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99655 min = 99655 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99655
max = 99655
avg = 99655
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.92 us (1.9%)
patch tree reduce : 1513.00 ns (0.4%)
gen split merge : 721.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1022.00 ns (0.3%)
LB compute : 345.86 us (94.5%)
LB move op cnt : 0
LB apply : 3.25 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.32 us (70.3%)
central potential accretion : += 4e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-5.43513869145383e-10,-2.790757862104926e-09,9.645125717333317e-11)
sum a = (1.265972231421219e-11,-1.974688967034801e-11,-2.2300682115446797e-12)
sum e = 1.2698306934168062e-10
sum de = -1.0231742825313066e-15
Info: CFL hydro = 1.5330446454417517 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.5330446454417517 cfl multiplier : 0.9999999999998618 [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 | 2.9218e+05 | 99651 | 3.411e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 17015.376060765662 (tsim/hr) [sph::Model][rank=0]
---------------- t = 108.82266202672977, dt = 1.5330446454417517 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99651 min = 99651 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99651 min = 99651 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99651
max = 99651
avg = 99651
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.40 us (1.7%)
patch tree reduce : 1523.00 ns (0.4%)
gen split merge : 752.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1483.00 ns (0.3%)
LB compute : 409.60 us (94.7%)
LB move op cnt : 0
LB apply : 3.64 us (0.8%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.42 us (71.8%)
central potential accretion : += 4e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010166503215138555 unconverged cnt = 4
Info: conservation infos : [sph::Model][rank=0]
sum v = (-5.062223308800616e-10,-2.8122916543736237e-09,8.649906970961038e-11)
sum a = (1.3244919627349942e-11,-1.9247740297608407e-11,-2.745941648889163e-12)
sum e = 1.2695766055873842e-10
sum de = -1.001565524877506e-15
Info: CFL hydro = 1.4709202160330312 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.4709202160330312 cfl multiplier : 0.999999999999908 [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.8824e+05 | 99647 | 5.294e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 10425.513403499821 (tsim/hr) [sph::Model][rank=0]
---------------- t = 110.35570667217152, dt = 1.4709202160330312 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99647 min = 99647 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99647 min = 99647 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99647
max = 99647
avg = 99647
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.75 us (2.1%)
patch tree reduce : 1804.00 ns (0.5%)
gen split merge : 671.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1683.00 ns (0.5%)
LB compute : 339.12 us (93.5%)
LB move op cnt : 0
LB apply : 4.07 us (1.1%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.14 us (70.6%)
central potential accretion : += 3.0000000000000004e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010166585022486675 unconverged cnt = 1
Info: conservation infos : [sph::Model][rank=0]
sum v = (-4.791950892005834e-10,-2.8385631328848493e-09,7.877290792107458e-11)
sum a = (1.393605101441026e-11,-1.8975373486122168e-11,-3.3470258491525306e-12)
sum e = 1.2693859213491816e-10
sum de = -9.541728733175279e-16
Info: CFL hydro = 1.4926719958950962 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.4926719958950962 cfl multiplier : 0.9999999999999387 [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.8907e+05 | 99644 | 5.270e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 10047.562803845114 (tsim/hr) [sph::Model][rank=0]
---------------- t = 111.82662688820456, dt = 1.4926719958950962 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99644 min = 99644 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99644 min = 99644 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99644
max = 99644
avg = 99644
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.12 us (1.9%)
patch tree reduce : 1463.00 ns (0.4%)
gen split merge : 882.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1182.00 ns (0.3%)
LB compute : 362.88 us (94.5%)
LB move op cnt : 0
LB apply : 3.59 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.23 us (70.6%)
central potential accretion : += 1e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-4.529506451070317e-10,-2.8578678031882683e-09,7.29107320475913e-11)
sum a = (1.4490065510375332e-11,-1.8744342929617678e-11,-3.8473729465277766e-12)
sum e = 1.2693270211235374e-10
sum de = -8.894418991127026e-16
Info: CFL hydro = 1.5465146983619373 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.5465146983619373 cfl multiplier : 0.9999999999999591 [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 | 2.9347e+05 | 99643 | 3.395e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 15826.484998009992 (tsim/hr) [sph::Model][rank=0]
---------------- t = 113.31929888409965, dt = 1.5465146983619373 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99643 min = 99643 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99643 min = 99643 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99643
max = 99643
avg = 99643
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.83 us (1.8%)
patch tree reduce : 1443.00 ns (0.3%)
gen split merge : 771.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1342.00 ns (0.3%)
LB compute : 420.59 us (94.7%)
LB move op cnt : 0
LB apply : 3.97 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.56 us (71.7%)
central potential accretion : += 5e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-4.0846865643554387e-10,-2.873837855069821e-09,5.850041573908944e-11)
sum a = (1.49904118244308e-11,-1.7956702504834504e-11,-4.376905514781107e-12)
sum e = 1.26907362966948e-10
sum de = -8.727835473358452e-16
Info: CFL hydro = 1.5234720507558615 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.5234720507558615 cfl multiplier : 0.9999999999999728 [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 | 2.9112e+05 | 99638 | 3.423e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 16266.796731930019 (tsim/hr) [sph::Model][rank=0]
---------------- t = 114.86581358246158, dt = 1.5234720507558615 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99638 min = 99638 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99638 min = 99638 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99638
max = 99638
avg = 99638
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.82 us (1.9%)
patch tree reduce : 1442.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 : 341.51 us (94.3%)
LB move op cnt : 0
LB apply : 3.68 us (1.0%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.16 us (69.4%)
central potential accretion : += 6.000000000000001e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-3.909476459308874e-10,-2.893113723958151e-09,5.6728450817162775e-11)
sum a = (1.556156563493669e-11,-1.796547156015447e-11,-4.90164116787578e-12)
sum e = 1.26874329909699e-10
sum de = -8.634754080446682e-16
Info: CFL hydro = 1.6046353858638178 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.6046353858638178 cfl multiplier : 0.9999999999999819 [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 | 2.9270e+05 | 99632 | 3.404e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 16112.448701722667 (tsim/hr) [sph::Model][rank=0]
---------------- t = 116.38928563321744, dt = 1.6046353858638178 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99632 min = 99632 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99632 min = 99632 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99632
max = 99632
avg = 99632
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.35 us (1.7%)
patch tree reduce : 1292.00 ns (0.3%)
gen split merge : 882.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1052.00 ns (0.3%)
LB compute : 359.41 us (94.6%)
LB move op cnt : 0
LB apply : 3.40 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.29 us (70.7%)
central potential accretion : += 2e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010166887746842108 unconverged cnt = 1
Info: conservation infos : [sph::Model][rank=0]
sum v = (-3.489353660845546e-10,-2.910795915638138e-09,4.281806600464399e-11)
sum a = (1.6103551526226527e-11,-1.7202198103908252e-11,-5.499025927997223e-12)
sum e = 1.2686530886667474e-10
sum de = -8.032545337210487e-16
Info: CFL hydro = 1.5489358986917916 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.5489358986917916 cfl multiplier : 0.9999999999999879 [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.8895e+05 | 99630 | 5.273e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 10955.488377893977 (tsim/hr) [sph::Model][rank=0]
---------------- t = 117.99392101908126, dt = 1.5489358986917916 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99630 min = 99630 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99630 min = 99630 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99630
max = 99630
avg = 99630
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.07 us (1.7%)
patch tree reduce : 1353.00 ns (0.3%)
gen split merge : 681.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1032.00 ns (0.3%)
LB compute : 386.40 us (94.9%)
LB move op cnt : 0
LB apply : 3.39 us (0.8%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.45 us (71.6%)
central potential accretion : += 1e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-3.1508999712895147e-10,-2.9318481742805073e-09,3.078853688265373e-11)
sum a = (1.6714048540786076e-11,-1.6617757956336074e-11,-6.149894993582499e-12)
sum e = 1.2685685169844565e-10
sum de = -7.284553994613979e-16
Info: CFL hydro = 1.4775323768820479 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.4775323768820479 cfl multiplier : 0.999999999999992 [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 | 2.9031e+05 | 99629 | 3.432e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 16248.442342358587 (tsim/hr) [sph::Model][rank=0]
---------------- t = 119.54285691777305, dt = 1.4775323768820479 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99629 min = 99629 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99629 min = 99629 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99629
max = 99629
avg = 99629
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.85 us (1.9%)
patch tree reduce : 1312.00 ns (0.4%)
gen split merge : 782.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1032.00 ns (0.3%)
LB compute : 342.83 us (94.5%)
LB move op cnt : 0
LB apply : 3.15 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.23 us (71.0%)
central potential accretion : += 3.0000000000000004e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010167012717824426 unconverged cnt = 3
Info: conservation infos : [sph::Model][rank=0]
sum v = (-2.767198282029829e-10,-2.9586057433325957e-09,1.307616095251392e-11)
sum a = (1.7430299233509122e-11,-1.578783725556218e-11,-6.927764733469038e-12)
sum e = 1.268378456927991e-10
sum de = -6.738138616599574e-16
Info: CFL hydro = 1.5489549748052491 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.5489549748052491 cfl multiplier : 0.9999999999999947 [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.8899e+05 | 99626 | 5.271e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 10090.529581304087 (tsim/hr) [sph::Model][rank=0]
---------------- t = 121.0203892946551, dt = 1.5489549748052491 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99626 min = 99626 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99626 min = 99626 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99626
max = 99626
avg = 99626
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.44 us (1.7%)
patch tree reduce : 1583.00 ns (0.4%)
gen split merge : 751.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1082.00 ns (0.3%)
LB compute : 368.89 us (94.9%)
LB move op cnt : 0
LB apply : 3.54 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.36 us (71.9%)
central potential accretion : += 2e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010167070726618611 unconverged cnt = 1
Info: conservation infos : [sph::Model][rank=0]
sum v = (-2.344017881839338e-10,-2.971296758173994e-09,-3.0709189130770782e-12)
sum a = (1.7876768284040722e-11,-1.489366582694397e-11,-7.501312664706808e-12)
sum e = 1.2682883966713057e-10
sum de = -6.06763129213243e-16
Info: CFL hydro = 1.483166300046774 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.483166300046774 cfl multiplier : 0.9999999999999964 [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.8906e+05 | 99624 | 5.269e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 10582.466398945542 (tsim/hr) [sph::Model][rank=0]
---------------- t = 122.56934426946036, dt = 1.225516393295365 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99624 min = 99624 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99624 min = 99624 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99624
max = 99624
avg = 99624
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.67 us (1.6%)
patch tree reduce : 1663.00 ns (0.4%)
gen split merge : 782.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1222.00 ns (0.3%)
LB compute : 390.09 us (95.0%)
LB move op cnt : 0
LB apply : 3.23 us (0.8%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.41 us (71.7%)
central potential accretion : += 2e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010167113781985069 unconverged cnt = 1
Info: conservation infos : [sph::Model][rank=0]
sum v = (-2.114286569354233e-10,-2.991433423738919e-09,-1.3923565757947458e-11)
sum a = (1.843878029739384e-11,-1.4442147143214086e-11,-8.113061932452741e-12)
sum e = 1.26807722383754e-10
sum de = -5.566202631693596e-16
Info: CFL hydro = 1.4392870000167484 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.4392870000167484 cfl multiplier : 0.9999999999999977 [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.8913e+05 | 99622 | 5.267e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 8375.681583117193 (tsim/hr) [sph::Model][rank=0]
Info: iteration since start : 84 [SPH][rank=0]
Info: time since start : 1392.2531409540002 (s) [SPH][rank=0]
Info: dump to _to_trash/black_hole_disc_lense_thirring_100000/dump/dump_0000005.vtk [VTK Dump][rank=0]
- took 7.87 ms, bandwidth = 676.29 MB/s
Info: Dumping state to _to_trash/black_hole_disc_lense_thirring_100000/dump/dump_0000005.sham [SPH][rank=0]
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.41 us (55.0%)
Info: dump to _to_trash/black_hole_disc_lense_thirring_100000/dump/dump_0000005.sham [Shamrock Dump][rank=0]
- took 10.84 ms, bandwidth = 1.03 GB/s
Info: compute_column_integ field_name: rho, center: (0,0,0), delta_x: (1.1845115302733742,0,0), delta_y: (0,1.1845115302733742,0), nx: 1024, ny: 1024 [sph::CartesianRender][rank=0]
Info: compute_column_integ took 624.19 ms [sph::CartesianRender][rank=0]
Info: compute_column_integ field_name: vxyz, center: (0,0,0), delta_x: (1.1845115302733742,0,0), delta_y: (0,1.1845115302733742,0), nx: 1024, ny: 1024 [sph::CartesianRender][rank=0]
Info: compute_column_integ took 627.89 ms [sph::CartesianRender][rank=0]
---------------- t = 123.79486066275572, dt = 1.4392870000167484 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99622 min = 99622 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99622 min = 99622 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99622
max = 99622
avg = 99622
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.20 us (1.8%)
patch tree reduce : 1803.00 ns (0.4%)
gen split merge : 791.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1262.00 ns (0.3%)
LB compute : 387.33 us (94.9%)
LB move op cnt : 0
LB apply : 3.23 us (0.8%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.52 us (68.6%)
central potential accretion : += 4e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010167161156062613 unconverged cnt = 1
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.712312233688594e-10,-2.9970250445872754e-09,-2.930759738460709e-11)
sum a = (1.872455061664322e-11,-1.354887097571686e-11,-8.569919956633954e-12)
sum e = 1.2679270353571859e-10
sum de = -5.133099413429771e-16
Info: CFL hydro = 1.6293385777433471 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.6293385777433471 cfl multiplier : 0.9999999999999986 [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.8910e+05 | 99618 | 5.268e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 9835.415585378432 (tsim/hr) [sph::Model][rank=0]
---------------- t = 125.23414766277247, dt = 1.6293385777433471 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99618 min = 99618 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99618 min = 99618 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99618
max = 99618
avg = 99618
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.45 us (1.8%)
patch tree reduce : 1343.00 ns (0.4%)
gen split merge : 671.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 992.00 ns (0.3%)
LB compute : 330.86 us (94.3%)
LB move op cnt : 0
LB apply : 3.33 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.52 us (68.7%)
central potential accretion : += 2e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.3881277976217496e-10,-3.022371872495745e-09,-4.6185266037466776e-11)
sum a = (1.9434436447315296e-11,-1.2800733916063375e-11,-9.39765359229784e-12)
sum e = 1.2678825229190483e-10
sum de = -4.3943814389913375e-16
Info: CFL hydro = 1.568595428855633 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.568595428855633 cfl multiplier : 0.9999999999999991 [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 | 2.9091e+05 | 99616 | 3.424e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 17129.166485649752 (tsim/hr) [sph::Model][rank=0]
---------------- t = 126.86348624051581, dt = 1.568595428855633 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99616 min = 99616 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99616 min = 99616 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99616
max = 99616
avg = 99616
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.37 us (2.1%)
patch tree reduce : 1412.00 ns (0.4%)
gen split merge : 751.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 982.00 ns (0.3%)
LB compute : 334.76 us (94.1%)
LB move op cnt : 0
LB apply : 3.39 us (1.0%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.19 us (68.6%)
central potential accretion : += 3.0000000000000004e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010167254144532296 unconverged cnt = 1
Info: conservation infos : [sph::Model][rank=0]
sum v = (-1.0255096541360698e-10,-3.03102446713306e-09,-6.095879779993558e-11)
sum a = (1.9805093548839085e-11,-1.1982106917332568e-11,-9.948664424306974e-12)
sum e = 1.2676986133978606e-10
sum de = -3.7218357749364303e-16
Info: CFL hydro = 1.5324765661062014 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.5324765661062014 cfl multiplier : 0.9999999999999994 [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.8957e+05 | 99613 | 5.255e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 10746.527680988971 (tsim/hr) [sph::Model][rank=0]
---------------- t = 128.43208166937146, dt = 1.5324765661062014 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99613 min = 99613 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99613 min = 99613 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99613
max = 99613
avg = 99613
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.97 us (2.0%)
patch tree reduce : 1262.00 ns (0.4%)
gen split merge : 862.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1042.00 ns (0.3%)
LB compute : 329.25 us (94.3%)
LB move op cnt : 0
LB apply : 3.12 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.25 us (70.8%)
central potential accretion : += 2e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-7.125080710778309e-11,-3.0298106995432583e-09,-7.042670598919889e-11)
sum a = (1.9995021354773565e-11,-1.1331733387042647e-11,-1.0295440366954515e-11)
sum e = 1.2675782023320193e-10
sum de = -2.7397897777953296e-16
Info: CFL hydro = 1.4602923624904658 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.4602923624904658 cfl multiplier : 0.9999999999999997 [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 | 2.9112e+05 | 99611 | 3.422e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 16123.318608300144 (tsim/hr) [sph::Model][rank=0]
---------------- t = 129.96455823547765, dt = 1.4602923624904658 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99611 min = 99611 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99611 min = 99611 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99611
max = 99611
avg = 99611
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.78 us (1.7%)
patch tree reduce : 1252.00 ns (0.3%)
gen split merge : 852.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 992.00 ns (0.2%)
LB compute : 388.29 us (95.2%)
LB move op cnt : 0
LB apply : 3.08 us (0.8%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.36 us (71.1%)
central potential accretion : += 3.0000000000000004e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (-3.8365251659673324e-11,-3.036312302700367e-09,-8.490871515852183e-11)
sum a = (2.0305965885675955e-11,-1.0529037017276967e-11,-1.0796227766776935e-11)
sum e = 1.2673985226547034e-10
sum de = -2.0970138948153804e-16
Info: CFL hydro = 1.513614068947905 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.513614068947905 cfl multiplier : 0.9999999999999997 [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 | 2.9191e+05 | 99608 | 3.412e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 15406.29931048129 (tsim/hr) [sph::Model][rank=0]
---------------- t = 131.42485059796812, dt = 1.513614068947905 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99608 min = 99608 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99608 min = 99608 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99608
max = 99608
avg = 99608
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.81 us (2.2%)
patch tree reduce : 1684.00 ns (0.5%)
gen split merge : 771.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1082.00 ns (0.3%)
LB compute : 330.74 us (93.7%)
LB move op cnt : 0
LB apply : 3.25 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.25 us (71.0%)
central potential accretion : += 5e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010167356708760901 unconverged cnt = 3
Info: conservation infos : [sph::Model][rank=0]
sum v = (2.4513050750157863e-12,-3.0474191064182415e-09,-1.0662333307882424e-10)
sum a = (2.0704510968869995e-11,-9.411134543765936e-12,-1.142268104174527e-11)
sum e = 1.2671545095474399e-10
sum de = -1.5570773001118687e-16
Info: CFL hydro = 1.449028099431326 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.449028099431326 cfl multiplier : 0.9999999999999997 [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.8937e+05 | 99603 | 5.260e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 10360.105001963868 (tsim/hr) [sph::Model][rank=0]
---------------- t = 132.93846466691602, dt = 1.449028099431326 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99603 min = 99603 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99603 min = 99603 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99603
max = 99603
avg = 99603
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.19 us (1.9%)
patch tree reduce : 1633.00 ns (0.4%)
gen split merge : 822.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1343.00 ns (0.4%)
LB compute : 331.23 us (89.3%)
LB move op cnt : 0
LB apply : 21.33 us (5.8%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.48 us (72.0%)
central potential accretion : += 1e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (4.024956642009042e-11,-3.053974588027521e-09,-1.265545760751086e-10)
sum a = (2.1009162200963328e-11,-8.365752420224304e-12,-1.1951053108313023e-11)
sum e = 1.2670789492092174e-10
sum de = -5.932898906938161e-17
Info: CFL hydro = 1.4814272755754254 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.4814272755754254 cfl multiplier : 0.9999999999999997 [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 | 2.8808e+05 | 99602 | 3.457e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 15087.806321816264 (tsim/hr) [sph::Model][rank=0]
---------------- t = 134.38749276634735, dt = 1.4814272755754254 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99602 min = 99602 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99602 min = 99602 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99602
max = 99602
avg = 99602
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.72 us (1.8%)
patch tree reduce : 1322.00 ns (0.4%)
gen split merge : 802.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1423.00 ns (0.4%)
LB compute : 349.76 us (94.4%)
LB move op cnt : 0
LB apply : 3.38 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.31 us (71.3%)
central potential accretion : += 2e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (6.912379690735195e-11,-3.0559306304711996e-09,-1.3846154356828326e-10)
sum a = (2.1228008890612264e-11,-7.632221936012114e-12,-1.237651787713647e-11)
sum e = 1.266988650525498e-10
sum de = 2.6064792151096872e-17
Info: CFL hydro = 1.4643199701799448 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.4643199701799448 cfl multiplier : 0.9999999999999997 [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 | 2.8292e+05 | 99600 | 3.520e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 15148.874617963922 (tsim/hr) [sph::Model][rank=0]
---------------- t = 135.86892004192276, dt = 1.4643199701799448 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99600 min = 99600 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99600 min = 99600 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99600
max = 99600
avg = 99600
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.77 us (1.8%)
patch tree reduce : 1493.00 ns (0.4%)
gen split merge : 722.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1312.00 ns (0.4%)
LB compute : 352.46 us (94.6%)
LB move op cnt : 0
LB apply : 3.37 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.23 us (68.4%)
central potential accretion : += 5e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.01016742505505963 unconverged cnt = 1
Info: conservation infos : [sph::Model][rank=0]
sum v = (1.0401289943447753e-10,-3.0359326971940866e-09,-1.4523691899752155e-10)
sum a = (2.1006816688046237e-11,-6.863997315495662e-12,-1.2415143124790485e-11)
sum e = 1.2667314438382193e-10
sum de = 9.338999609985158e-17
Info: CFL hydro = 1.4256686301229506 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.4256686301229506 cfl multiplier : 0.9999999999999997 [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.8924e+05 | 99595 | 5.263e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 10016.491949651472 (tsim/hr) [sph::Model][rank=0]
---------------- t = 137.33324001210272, dt = 1.4256686301229506 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99595 min = 99595 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99595 min = 99595 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99595
max = 99595
avg = 99595
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.59 us (1.7%)
patch tree reduce : 1293.00 ns (0.3%)
gen split merge : 661.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1022.00 ns (0.3%)
LB compute : 361.96 us (94.7%)
LB move op cnt : 0
LB apply : 3.63 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.40 us (67.0%)
central potential accretion : += 4e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010167440582383332 unconverged cnt = 5
Info: conservation infos : [sph::Model][rank=0]
sum v = (1.6222313127298763e-10,-3.022209040411489e-09,-1.7641025796059032e-10)
sum a = (2.0888905485065994e-11,-5.134779856338696e-12,-1.2661558288866851e-11)
sum e = 1.2665166457355313e-10
sum de = 1.569626731192406e-16
Info: CFL hydro = 1.3488268952007858 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.3488268952007858 cfl multiplier : 0.9999999999999997 [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.8936e+05 | 99591 | 5.259e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 9758.624153095083 (tsim/hr) [sph::Model][rank=0]
---------------- t = 138.75890864222566, dt = 1.3488268952007858 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99591 min = 99591 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99591 min = 99591 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99591
max = 99591
avg = 99591
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.65 us (1.7%)
patch tree reduce : 1543.00 ns (0.4%)
gen split merge : 1093.00 ns (0.3%)
split / merge op : 0/0
apply split merge : 992.00 ns (0.2%)
LB compute : 380.81 us (94.9%)
LB move op cnt : 0
LB apply : 3.28 us (0.8%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.44 us (72.2%)
central potential accretion : += 3.0000000000000004e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (1.9365499443025926e-10,-3.012840067790206e-09,-1.8944433109155904e-10)
sum a = (2.0857752400114533e-11,-4.2830651505456644e-12,-1.2873211971539241e-11)
sum e = 1.266341817094573e-10
sum de = 2.307583379417728e-16
Info: CFL hydro = 1.2908067988828975 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.2908067988828975 cfl multiplier : 0.9999999999999997 [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 | 2.8976e+05 | 99588 | 3.437e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 14128.431108978835 (tsim/hr) [sph::Model][rank=0]
---------------- t = 140.10773553742644, dt = 1.2908067988828975 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99588 min = 99588 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99588 min = 99588 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99588
max = 99588
avg = 99588
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.54 us (1.7%)
patch tree reduce : 1173.00 ns (0.3%)
gen split merge : 1051.00 ns (0.3%)
split / merge op : 0/0
apply split merge : 1012.00 ns (0.3%)
LB compute : 360.93 us (94.7%)
LB move op cnt : 0
LB apply : 3.44 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.27 us (70.6%)
central potential accretion : += 6.000000000000001e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010167460815917195 unconverged cnt = 6
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010167460815930002 unconverged cnt = 2
Info: conservation infos : [sph::Model][rank=0]
sum v = (2.0528447292712234e-10,-3.0153716758160792e-09,-1.9265708182075013e-10)
sum a = (2.1050171396856814e-11,-4.013556680696614e-12,-1.3209654189200258e-11)
sum e = 1.2660221111567433e-10
sum de = 2.725315579350345e-16
Info: CFL hydro = 1.246309453218012 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.246309453218012 cfl multiplier : 0.9999999999999997 [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.4020e+05 | 99582 | 7.103e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 6542.503111773804 (tsim/hr) [sph::Model][rank=0]
---------------- t = 141.39854233630933, dt = 1.246309453218012 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99582 min = 99582 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99582 min = 99582 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99582
max = 99582
avg = 99582
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 8.04 us (2.1%)
patch tree reduce : 1843.00 ns (0.5%)
gen split merge : 1122.00 ns (0.3%)
split / merge op : 0/0
apply split merge : 1323.00 ns (0.3%)
LB compute : 364.28 us (93.8%)
LB move op cnt : 0
LB apply : 3.91 us (1.0%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.50 us (72.0%)
central potential accretion : += 5e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (2.2984097383229152e-10,-3.0186722731395523e-09,-2.0702319420016268e-10)
sum a = (2.125242143384002e-11,-3.2664164626662852e-12,-1.3602597438162529e-11)
sum e = 1.2657575234298697e-10
sum de = 3.3174103554079127e-16
Info: CFL hydro = 1.2118352502258898 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.2118352502258898 cfl multiplier : 0.9999999999999997 [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 | 2.9246e+05 | 99577 | 3.405e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 13177.548138570144 (tsim/hr) [sph::Model][rank=0]
---------------- t = 142.64485178952734, dt = 1.2118352502258898 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99577 min = 99577 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99577 min = 99577 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99577
max = 99577
avg = 99577
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.15 us (2.0%)
patch tree reduce : 1412.00 ns (0.4%)
gen split merge : 732.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1172.00 ns (0.3%)
LB compute : 330.92 us (94.2%)
LB move op cnt : 0
LB apply : 3.09 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.54 us (68.9%)
central potential accretion : += 2e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (2.57157478796353e-10,-3.026065938133145e-09,-2.2723443573504425e-10)
sum a = (2.152107457246308e-11,-2.3315430394286125e-12,-1.4071926757554484e-11)
sum e = 1.2656513339506163e-10
sum de = 4.064517410952173e-16
Info: CFL hydro = 1.2874516146974795 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.2874516146974795 cfl multiplier : 0.9999999999999997 [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 | 2.9335e+05 | 99575 | 3.394e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 12852.463890302399 (tsim/hr) [sph::Model][rank=0]
---------------- t = 143.85668703975324, dt = 1.2874516146974795 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99575 min = 99575 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99575 min = 99575 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99575
max = 99575
avg = 99575
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 8.13 us (2.1%)
patch tree reduce : 1733.00 ns (0.4%)
gen split merge : 952.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1312.00 ns (0.3%)
LB compute : 366.10 us (93.8%)
LB move op cnt : 0
LB apply : 3.95 us (1.0%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.15 us (69.8%)
central potential accretion : += 4e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (2.7644935372085553e-10,-3.0086483871541153e-09,-2.2676309617261476e-10)
sum a = (2.1296788395188763e-11,-1.9537048707187903e-12,-1.4073440852296015e-11)
sum e = 1.2654783837820913e-10
sum de = 4.729153102609052e-16
Info: CFL hydro = 1.2473188289829753 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.2473188289829753 cfl multiplier : 0.9999999999999997 [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 | 2.9333e+05 | 99571 | 3.395e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 13653.872555122 (tsim/hr) [sph::Model][rank=0]
---------------- t = 145.14413865445073, dt = 1.2473188289829753 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99571 min = 99571 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99571 min = 99571 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99571
max = 99571
avg = 99571
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.56 us (1.9%)
patch tree reduce : 1583.00 ns (0.4%)
gen split merge : 711.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1242.00 ns (0.3%)
LB compute : 379.63 us (94.4%)
LB move op cnt : 0
LB apply : 3.81 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.15 us (70.5%)
central potential accretion : += 4e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010167469111045435 unconverged cnt = 2
Info: conservation infos : [sph::Model][rank=0]
sum v = (2.7752451711394845e-10,-3.027971806359275e-09,-2.2722856513546033e-10)
sum a = (2.178267416467576e-11,-1.9075104085286134e-12,-1.4683395556670454e-11)
sum e = 1.2652725834184703e-10
sum de = 5.219784486197107e-16
Info: CFL hydro = 1.1917762080142627 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.1917762080142627 cfl multiplier : 0.9999999999999997 [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.8832e+05 | 99567 | 5.287e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 8493.152052372216 (tsim/hr) [sph::Model][rank=0]
---------------- t = 146.3914574834337, dt = 1.1917762080142627 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99567 min = 99567 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99567 min = 99567 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99567
max = 99567
avg = 99567
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.48 us (2.1%)
patch tree reduce : 1563.00 ns (0.4%)
gen split merge : 1051.00 ns (0.3%)
split / merge op : 0/0
apply split merge : 1502.00 ns (0.4%)
LB compute : 339.49 us (93.8%)
LB move op cnt : 0
LB apply : 3.64 us (1.0%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.25 us (70.0%)
central potential accretion : += 3.0000000000000004e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010167465343888151 unconverged cnt = 1
Info: conservation infos : [sph::Model][rank=0]
sum v = (2.824289757734099e-10,-3.0402939489671414e-09,-2.291205440287227e-10)
sum a = (2.21273568335846e-11,-1.7506537976784534e-12,-1.5163617175662938e-11)
sum e = 1.2651165390761747e-10
sum de = 5.657797728928486e-16
Info: CFL hydro = 1.1963813413116786 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.1963813413116786 cfl multiplier : 0.9999999999999997 [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.9010e+05 | 99564 | 5.238e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 8191.663419708308 (tsim/hr) [sph::Model][rank=0]
---------------- t = 147.58323369144796, dt = 0.9705991038588877 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99564 min = 99564 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99564 min = 99564 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99564
max = 99564
avg = 99564
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.83 us (2.1%)
patch tree reduce : 1613.00 ns (0.4%)
gen split merge : 1012.00 ns (0.3%)
split / merge op : 0/0
apply split merge : 1323.00 ns (0.4%)
LB compute : 350.04 us (93.6%)
LB move op cnt : 0
LB apply : 3.93 us (1.1%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.56 us (68.5%)
central potential accretion : += 3.0000000000000004e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010167460651396891 unconverged cnt = 1
Info: conservation infos : [sph::Model][rank=0]
sum v = (2.9683437410938823e-10,-3.047870606647233e-09,-2.407199339466862e-10)
sum a = (2.236696140109821e-11,-1.220600246889327e-12,-1.5531476950339827e-11)
sum e = 1.2649192382860688e-10
sum de = 5.989465212020795e-16
Info: CFL hydro = 1.2128031892810087 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.2128031892810087 cfl multiplier : 0.9999999999999997 [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.9003e+05 | 99561 | 5.239e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 6669.127988516597 (tsim/hr) [sph::Model][rank=0]
Info: iteration since start : 102 [SPH][rank=0]
Info: time since start : 1401.6558438010002 (s) [SPH][rank=0]
Info: dump to _to_trash/black_hole_disc_lense_thirring_100000/dump/dump_0000006.vtk [VTK Dump][rank=0]
- took 7.86 ms, bandwidth = 676.59 MB/s
Info: Dumping state to _to_trash/black_hole_disc_lense_thirring_100000/dump/dump_0000006.sham [SPH][rank=0]
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.16 us (52.9%)
Info: dump to _to_trash/black_hole_disc_lense_thirring_100000/dump/dump_0000006.sham [Shamrock Dump][rank=0]
- took 11.33 ms, bandwidth = 1006.45 MB/s
Info: compute_column_integ field_name: rho, center: (0,0,0), delta_x: (1.1845115302733742,0,0), delta_y: (0,1.1845115302733742,0), nx: 1024, ny: 1024 [sph::CartesianRender][rank=0]
Info: compute_column_integ took 624.14 ms [sph::CartesianRender][rank=0]
Info: compute_column_integ field_name: vxyz, center: (0,0,0), delta_x: (1.1845115302733742,0,0), delta_y: (0,1.1845115302733742,0), nx: 1024, ny: 1024 [sph::CartesianRender][rank=0]
Info: compute_column_integ took 629.52 ms [sph::CartesianRender][rank=0]
---------------- t = 148.55383279530685, dt = 1.2128031892810087 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99561 min = 99561 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99561 min = 99561 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99561
max = 99561
avg = 99561
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 9.59 us (2.0%)
patch tree reduce : 1743.00 ns (0.4%)
gen split merge : 1122.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1412.00 ns (0.3%)
LB compute : 454.39 us (94.4%)
LB move op cnt : 0
LB apply : 4.71 us (1.0%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.63 us (73.1%)
central potential accretion : += 2e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.01016745274571525 unconverged cnt = 1
Info: conservation infos : [sph::Model][rank=0]
sum v = (3.1055803745556397e-10,-3.050678820752184e-09,-2.458324210366996e-10)
sum a = (2.251109792337301e-11,-8.133321028123131e-13,-1.587306822663157e-11)
sum e = 1.264888568816978e-10
sum de = 6.609870792927503e-16
Info: CFL hydro = 1.1672380993758729 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.1672380993758729 cfl multiplier : 0.9999999999999997 [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.8731e+05 | 99559 | 5.315e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 8214.526704178405 (tsim/hr) [sph::Model][rank=0]
---------------- t = 149.76663598458785, dt = 1.1672380993758729 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99559 min = 99559 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99559 min = 99559 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99559
max = 99559
avg = 99559
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.82 us (1.8%)
patch tree reduce : 1493.00 ns (0.4%)
gen split merge : 711.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1022.00 ns (0.3%)
LB compute : 365.64 us (94.6%)
LB move op cnt : 0
LB apply : 3.51 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.52 us (71.8%)
central potential accretion : += 1e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (3.321657604277631e-10,-3.0465580049349004e-09,-2.5704415657846195e-10)
sum a = (2.2517628689870357e-11,-1.304955121460434e-13,-1.6102450167184123e-11)
sum e = 1.2648350006493008e-10
sum de = 7.483830520597185e-16
Info: CFL hydro = 1.0873251194672473 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.0873251194672473 cfl multiplier : 0.9999999999999997 [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 | 2.9300e+05 | 99558 | 3.398e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 12366.597425218035 (tsim/hr) [sph::Model][rank=0]
---------------- t = 150.93387408396373, dt = 1.0873251194672473 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99558 min = 99558 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99558 min = 99558 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99558
max = 99558
avg = 99558
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 8.43 us (2.3%)
patch tree reduce : 1483.00 ns (0.4%)
gen split merge : 841.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1082.00 ns (0.3%)
LB compute : 346.14 us (93.6%)
LB move op cnt : 0
LB apply : 4.01 us (1.1%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.25 us (70.5%)
central potential accretion : += 2e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010167432049061698 unconverged cnt = 4
Info: conservation infos : [sph::Model][rank=0]
sum v = (3.7039203400069915e-10,-3.0352799966542694e-09,-2.841903522225087e-10)
sum a = (2.2393565618819515e-11,1.1882662475481749e-12,-1.6229330197851715e-11)
sum e = 1.2647239919660573e-10
sum de = 8.112496282929539e-16
Info: CFL hydro = 1.025817421212416 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.025817421212416 cfl multiplier : 0.9999999999999997 [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.8828e+05 | 99556 | 5.288e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 7402.69920534739 (tsim/hr) [sph::Model][rank=0]
---------------- t = 152.02119920343097, dt = 1.025817421212416 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99556 min = 99556 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99556 min = 99556 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99556
max = 99556
avg = 99556
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.10 us (1.9%)
patch tree reduce : 1383.00 ns (0.4%)
gen split merge : 811.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1102.00 ns (0.3%)
LB compute : 346.19 us (94.3%)
LB move op cnt : 0
LB apply : 3.27 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.88 us (70.5%)
central potential accretion : += 2e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (4.033478084325023e-10,-3.033354552580945e-09,-3.11747176119183e-10)
sum a = (2.2465985263601736e-11,2.4169985702650537e-12,-1.649515336457748e-11)
sum e = 1.2646173468223556e-10
sum de = 8.790071583284538e-16
Info: CFL hydro = 0.9771914304775728 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.9771914304775728 cfl multiplier : 0.9999999999999997 [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 | 2.9422e+05 | 99554 | 3.384e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 10914.027372600427 (tsim/hr) [sph::Model][rank=0]
---------------- t = 153.0470166246434, dt = 0.9771914304775728 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99554 min = 99554 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99554 min = 99554 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99554
max = 99554
avg = 99554
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.79 us (1.9%)
patch tree reduce : 1443.00 ns (0.4%)
gen split merge : 1102.00 ns (0.3%)
split / merge op : 0/0
apply split merge : 1163.00 ns (0.3%)
LB compute : 335.30 us (94.1%)
LB move op cnt : 0
LB apply : 3.23 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.29 us (70.9%)
central potential accretion : += 3.0000000000000004e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (4.2017528363124426e-10,-3.029300683761213e-09,-3.2188069851967685e-10)
sum a = (2.245874278937905e-11,2.97948179177178e-12,-1.6652862549981952e-11)
sum e = 1.2644651228449049e-10
sum de = 9.224918103698549e-16
Info: CFL hydro = 0.9379345072242002 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.9379345072242002 cfl multiplier : 0.9999999999999997 [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 | 2.9526e+05 | 99551 | 3.372e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 10433.86984566682 (tsim/hr) [sph::Model][rank=0]
---------------- t = 154.02420805512097, dt = 0.9379345072242002 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99551 min = 99551 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99551 min = 99551 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99551
max = 99551
avg = 99551
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.45 us (1.7%)
patch tree reduce : 1283.00 ns (0.3%)
gen split merge : 701.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1013.00 ns (0.3%)
LB compute : 359.74 us (94.9%)
LB move op cnt : 0
LB apply : 3.12 us (0.8%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.35 us (71.9%)
central potential accretion : += 1e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (4.3431167579040436e-10,-3.030656506540824e-09,-3.3210003701608164e-10)
sum a = (2.2553647918929493e-11,3.5067842075234946e-12,-1.6896941391823907e-11)
sum e = 1.2644160722043113e-10
sum de = 9.805381547368041e-16
Info: CFL hydro = 0.9057962728751398 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.9057962728751398 cfl multiplier : 0.9999999999999997 [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 | 2.9435e+05 | 99550 | 3.382e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 9983.964535193481 (tsim/hr) [sph::Model][rank=0]
---------------- t = 154.96214256234518, dt = 0.9057962728751398 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99550 min = 99550 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99550 min = 99550 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99550
max = 99550
avg = 99550
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.34 us (1.8%)
patch tree reduce : 1373.00 ns (0.4%)
gen split merge : 1153.00 ns (0.3%)
split / merge op : 0/0
apply split merge : 982.00 ns (0.3%)
LB compute : 325.61 us (94.3%)
LB move op cnt : 0
LB apply : 3.06 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.26 us (70.2%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (4.54748537615391e-10,-3.027117680183146e-09,-3.4749215334925484e-10)
sum a = (2.2555862446851003e-11,4.25756111911814e-12,-1.7059486989119507e-11)
sum e = 1.2644187441478937e-10
sum de = 1.0544136467272619e-15
Info: CFL hydro = 0.9097768796390899 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.9097768796390899 cfl multiplier : 0.9999999999999997 [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 | 2.9664e+05 | 99550 | 3.356e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 9716.706147231711 (tsim/hr) [sph::Model][rank=0]
---------------- t = 155.86793883522031, dt = 0.9097768796390899 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99550 min = 99550 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99550 min = 99550 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99550
max = 99550
avg = 99550
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.52 us (1.9%)
patch tree reduce : 1283.00 ns (0.4%)
gen split merge : 1072.00 ns (0.3%)
split / merge op : 0/0
apply split merge : 982.00 ns (0.3%)
LB compute : 328.75 us (94.2%)
LB move op cnt : 0
LB apply : 2.92 us (0.8%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.15 us (70.3%)
central potential accretion : += 3.0000000000000004e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (4.65180159091219e-10,-3.036335386872434e-09,-3.5735105184803733e-10)
sum a = (2.2805802488931942e-11,4.704625790612323e-12,-1.743222596490678e-11)
sum e = 1.2642800068827244e-10
sum de = 1.0895552745826687e-15
Info: CFL hydro = 0.929392013238002 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.929392013238002 cfl multiplier : 0.9999999999999997 [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 | 2.9496e+05 | 99547 | 3.375e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 9704.33013404215 (tsim/hr) [sph::Model][rank=0]
---------------- t = 156.7777157148594, dt = 0.929392013238002 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99547 min = 99547 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99547 min = 99547 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99547
max = 99547
avg = 99547
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.59 us (1.7%)
patch tree reduce : 1292.00 ns (0.3%)
gen split merge : 841.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 982.00 ns (0.3%)
LB compute : 358.61 us (94.6%)
LB move op cnt : 0
LB apply : 3.56 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.14 us (69.9%)
central potential accretion : += 3.0000000000000004e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (4.91532868854412e-10,-3.0204727363165017e-09,-3.7471471805753366e-10)
sum a = (2.2588058000525166e-11,5.609744161526781e-12,-1.7371624344159604e-11)
sum e = 1.264143683690896e-10
sum de = 1.1435011483506732e-15
Info: CFL hydro = 0.8974383805162509 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.8974383805162509 cfl multiplier : 0.9999999999999997 [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 | 2.9449e+05 | 99544 | 3.380e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 9898.150766277264 (tsim/hr) [sph::Model][rank=0]
---------------- t = 157.7071077280974, dt = 0.8974383805162509 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99544 min = 99544 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99544 min = 99544 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99544
max = 99544
avg = 99544
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.77 us (2.0%)
patch tree reduce : 1362.00 ns (0.4%)
gen split merge : 761.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1012.00 ns (0.3%)
LB compute : 323.55 us (93.9%)
LB move op cnt : 0
LB apply : 3.17 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.60 us (71.1%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (5.117935620282294e-10,-3.0150752037430175e-09,-3.903670529102709e-10)
sum a = (2.2551024686844167e-11,6.36562615183622e-12,-1.748552564941828e-11)
sum e = 1.2641478238044188e-10
sum de = 1.2157472649861705e-15
Info: CFL hydro = 0.8719153619608417 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.8719153619608417 cfl multiplier : 0.9999999999999997 [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 | 2.9282e+05 | 99544 | 3.399e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 9503.693828058387 (tsim/hr) [sph::Model][rank=0]
---------------- t = 158.60454610861368, dt = 0.8719153619608417 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99544 min = 99544 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99544 min = 99544 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99544
max = 99544
avg = 99544
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.10 us (1.9%)
patch tree reduce : 1542.00 ns (0.4%)
gen split merge : 772.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1042.00 ns (0.3%)
LB compute : 361.74 us (94.6%)
LB move op cnt : 0
LB apply : 3.66 us (1.0%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.29 us (70.8%)
central potential accretion : += 4e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010167308722250717 unconverged cnt = 1
Info: conservation infos : [sph::Model][rank=0]
sum v = (5.187266349375706e-10,-3.011395160095831e-09,-3.917578357656828e-10)
sum a = (2.2508306808283807e-11,6.5814467371191925e-12,-1.7594373228565993e-11)
sum e = 1.2639483837021759e-10
sum de = 1.2570349280431417e-15
Info: CFL hydro = 0.9213792687635386 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.9213792687635386 cfl multiplier : 0.9999999999999997 [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.8818e+05 | 99540 | 5.290e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 5934.049019759066 (tsim/hr) [sph::Model][rank=0]
---------------- t = 159.47646147057452, dt = 0.9213792687635386 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99540 min = 99540 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99540 min = 99540 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99540
max = 99540
avg = 99540
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 8.16 us (2.2%)
patch tree reduce : 1503.00 ns (0.4%)
gen split merge : 852.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1333.00 ns (0.4%)
LB compute : 348.31 us (93.5%)
LB move op cnt : 0
LB apply : 3.95 us (1.1%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.06 us (68.9%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (5.394477286224343e-10,-3.005008943526955e-09,-4.0801505442349363e-10)
sum a = (2.2448595315430425e-11,7.360323997775251e-12,-1.76874176486918e-11)
sum e = 1.2639701727146372e-10
sum de = 1.3308412672154043e-15
Info: CFL hydro = 0.8875553638536003 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.8875553638536003 cfl multiplier : 0.9999999999999997 [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 | 2.9744e+05 | 99540 | 3.347e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 9911.678455472984 (tsim/hr) [sph::Model][rank=0]
---------------- t = 160.39784073933805, dt = 0.8875553638536003 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99540 min = 99540 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99540 min = 99540 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99540
max = 99540
avg = 99540
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.03 us (1.9%)
patch tree reduce : 1272.00 ns (0.4%)
gen split merge : 681.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 982.00 ns (0.3%)
LB compute : 342.21 us (94.3%)
LB move op cnt : 0
LB apply : 3.46 us (1.0%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.28 us (70.8%)
central potential accretion : += 1e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (5.649779386317283e-10,-2.990264353820007e-09,-4.2672858884395953e-10)
sum a = (2.2239076802762937e-11,8.268184388109993e-12,-1.762530646065759e-11)
sum e = 1.2639243595132515e-10
sum de = 1.3965032048946067e-15
Info: CFL hydro = 0.8813506840503653 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.8813506840503653 cfl multiplier : 0.9999999999999997 [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 | 2.9436e+05 | 99539 | 3.382e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 9448.859570939949 (tsim/hr) [sph::Model][rank=0]
---------------- t = 161.28539610319166, dt = 0.8813506840503653 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99539 min = 99539 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99539 min = 99539 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99539
max = 99539
avg = 99539
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.49 us (1.7%)
patch tree reduce : 2.14 us (0.5%)
gen split merge : 772.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1282.00 ns (0.3%)
LB compute : 425.94 us (94.8%)
LB move op cnt : 0
LB apply : 3.94 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.29 us (72.4%)
central potential accretion : += 3.0000000000000004e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010167243821223531 unconverged cnt = 2
Info: conservation infos : [sph::Model][rank=0]
sum v = (5.827582692710034e-10,-2.993836056148706e-09,-4.4587513195833643e-10)
sum a = (2.2369148403401673e-11,9.024886004743275e-12,-1.78639714236052e-11)
sum e = 1.2637825064412758e-10
sum de = 1.4355342236480805e-15
Info: CFL hydro = 0.9365152054462369 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.9365152054462369 cfl multiplier : 0.9999999999999997 [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.9145e+05 | 99536 | 5.199e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 6102.639581199822 (tsim/hr) [sph::Model][rank=0]
---------------- t = 162.16674678724203, dt = 0.9365152054462369 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99536 min = 99536 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99536 min = 99536 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99536
max = 99536
avg = 99536
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.68 us (1.9%)
patch tree reduce : 1182.00 ns (0.3%)
gen split merge : 761.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1082.00 ns (0.3%)
LB compute : 332.30 us (94.3%)
LB move op cnt : 0
LB apply : 3.07 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.19 us (69.1%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (6.036685258707285e-10,-2.985055485797402e-09,-4.626281098308127e-10)
sum a = (2.2264147905027997e-11,9.817411254693831e-12,-1.7900907749105055e-11)
sum e = 1.2638074471350332e-10
sum de = 1.510186281955632e-15
Info: CFL hydro = 0.9205393479893881 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.9205393479893881 cfl multiplier : 0.9999999999999997 [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 | 2.9769e+05 | 99536 | 3.344e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 10083.242673470912 (tsim/hr) [sph::Model][rank=0]
---------------- t = 163.10326199268826, dt = 0.9205393479893881 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99536 min = 99536 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99536 min = 99536 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99536
max = 99536
avg = 99536
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.29 us (1.6%)
patch tree reduce : 1293.00 ns (0.3%)
gen split merge : 821.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 981.00 ns (0.2%)
LB compute : 380.11 us (95.1%)
LB move op cnt : 0
LB apply : 3.30 us (0.8%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.45 us (71.2%)
central potential accretion : += 1e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (6.300479476016546e-10,-2.9689745545377447e-09,-4.834886662072659e-10)
sum a = (2.2031905529153016e-11,1.079097773856418e-11,-1.7808280483991196e-11)
sum e = 1.2637688537447936e-10
sum de = 1.5683035226416522e-15
Info: CFL hydro = 0.9083336801498355 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.9083336801498355 cfl multiplier : 0.9999999999999997 [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 | 2.9668e+05 | 99535 | 3.355e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 9877.738605080647 (tsim/hr) [sph::Model][rank=0]
---------------- t = 164.02380134067764, dt = 0.9083336801498355 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99535 min = 99535 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99535 min = 99535 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99535
max = 99535
avg = 99535
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.00 us (1.5%)
patch tree reduce : 1302.00 ns (0.3%)
gen split merge : 1012.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 961.00 ns (0.2%)
LB compute : 385.85 us (95.3%)
LB move op cnt : 0
LB apply : 3.19 us (0.8%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.67 us (69.5%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (6.500055247935248e-10,-2.958817209914856e-09,-4.996703787125415e-10)
sum a = (2.190036190924117e-11,1.1550541410705209e-11,-1.7802313498680854e-11)
sum e = 1.2637809906852706e-10
sum de = 1.6401550367229873e-15
Info: CFL hydro = 0.8991189517224198 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.8991189517224198 cfl multiplier : 0.9999999999999997 [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 | 2.9778e+05 | 99535 | 3.343e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 9783.017419246458 (tsim/hr) [sph::Model][rank=0]
---------------- t = 164.93213502082747, dt = 0.8991189517224198 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99535 min = 99535 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99535 min = 99535 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99535
max = 99535
avg = 99535
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.83 us (1.9%)
patch tree reduce : 1443.00 ns (0.4%)
gen split merge : 791.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1042.00 ns (0.3%)
LB compute : 345.88 us (94.4%)
LB move op cnt : 0
LB apply : 3.61 us (1.0%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.31 us (69.5%)
central potential accretion : += 3.0000000000000004e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010167138305003728 unconverged cnt = 1
Info: conservation infos : [sph::Model][rank=0]
sum v = (6.736706109370036e-10,-2.9443067303063296e-09,-5.200939285218543e-10)
sum a = (2.171991447592374e-11,1.2471064015412816e-11,-1.7702259789993612e-11)
sum e = 1.26364366877414e-10
sum de = 1.6691548389831193e-15
Info: CFL hydro = 0.8923469106770278 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.8923469106770278 cfl multiplier : 0.9999999999999997 [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.9137e+05 | 99532 | 5.201e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 6223.452514045164 (tsim/hr) [sph::Model][rank=0]
---------------- t = 165.8312539725499, dt = 0.8923469106770278 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99532 min = 99532 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99532 min = 99532 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99532
max = 99532
avg = 99532
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 8.13 us (2.0%)
patch tree reduce : 1573.00 ns (0.4%)
gen split merge : 1132.00 ns (0.3%)
split / merge op : 0/0
apply split merge : 1422.00 ns (0.4%)
LB compute : 378.57 us (93.7%)
LB move op cnt : 0
LB apply : 4.08 us (1.0%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.48 us (72.2%)
central potential accretion : += 3.0000000000000004e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010167109647341148 unconverged cnt = 4
Info: conservation infos : [sph::Model][rank=0]
sum v = (6.764099436069515e-10,-2.9380351892649994e-09,-5.169366086095107e-10)
sum a = (2.1598141876902072e-11,1.250801084511185e-11,-1.7743087497055276e-11)
sum e = 1.263506395300757e-10
sum de = 1.708067493007458e-15
Info: CFL hydro = 0.8879389127158044 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.8879389127158044 cfl multiplier : 0.9999999999999997 [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.8975e+05 | 99529 | 5.245e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 6124.378030082675 (tsim/hr) [sph::Model][rank=0]
---------------- t = 166.7236008832269, dt = 0.8879389127158044 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99529 min = 99529 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99529 min = 99529 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99529
max = 99529
avg = 99529
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.52 us (1.7%)
patch tree reduce : 1463.00 ns (0.4%)
gen split merge : 1002.00 ns (0.3%)
split / merge op : 0/0
apply split merge : 1162.00 ns (0.3%)
LB compute : 372.73 us (94.8%)
LB move op cnt : 0
LB apply : 3.32 us (0.8%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.52 us (69.6%)
central potential accretion : += 4e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010167079986208827 unconverged cnt = 4
Info: conservation infos : [sph::Model][rank=0]
sum v = (6.910823094770705e-10,-2.9361849360461463e-09,-5.309717188127868e-10)
sum a = (2.1633457106321873e-11,1.3110006705631104e-11,-1.7869726818793766e-11)
sum e = 1.263320353735271e-10
sum de = 1.729340915837663e-15
Info: CFL hydro = 0.8806706740802596 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.8806706740802596 cfl multiplier : 0.9999999999999997 [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.9198e+05 | 99525 | 5.184e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 6165.970582922998 (tsim/hr) [sph::Model][rank=0]
---------------- t = 167.61153979594272, dt = 0.8806706740802596 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99525 min = 99525 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99525 min = 99525 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99525
max = 99525
avg = 99525
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.29 us (1.8%)
patch tree reduce : 1363.00 ns (0.4%)
gen split merge : 812.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1163.00 ns (0.3%)
LB compute : 329.23 us (94.4%)
LB move op cnt : 0
LB apply : 3.20 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.28 us (69.7%)
central potential accretion : += 1e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010167049443060646 unconverged cnt = 1
Info: conservation infos : [sph::Model][rank=0]
sum v = (7.041640770709318e-10,-2.928614575884277e-09,-5.400339943113535e-10)
sum a = (2.1523501110078296e-11,1.3590465159080492e-11,-1.7892951754336923e-11)
sum e = 1.2632855649639453e-10
sum de = 1.7837022986746594e-15
Info: CFL hydro = 0.8775721153620895 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.8775721153620895 cfl multiplier : 0.9999999999999997 [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.9135e+05 | 99524 | 5.201e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 6095.567361209546 (tsim/hr) [sph::Model][rank=0]
---------------- t = 168.49221047002297, dt = 0.8775721153620895 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99524 min = 99524 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99524 min = 99524 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99524
max = 99524
avg = 99524
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.56 us (1.7%)
patch tree reduce : 1503.00 ns (0.4%)
gen split merge : 762.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1132.00 ns (0.3%)
LB compute : 369.95 us (94.6%)
LB move op cnt : 0
LB apply : 3.70 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.42 us (71.5%)
central potential accretion : += 1e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (7.176072707699622e-10,-2.9241768111184973e-09,-5.522993513343483e-10)
sum a = (2.1477881385897832e-11,1.414521517975237e-11,-1.795186409571908e-11)
sum e = 1.2632501126101308e-10
sum de = 1.838518035854875e-15
Info: CFL hydro = 0.9138771434310969 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.9138771434310969 cfl multiplier : 0.9999999999999997 [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 | 2.9631e+05 | 99523 | 3.359e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 9406.145927727535 (tsim/hr) [sph::Model][rank=0]
---------------- t = 169.36978258538505, dt = 0.9138771434310969 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99523 min = 99523 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99523 min = 99523 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99523
max = 99523
avg = 99523
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.80 us (2.1%)
patch tree reduce : 1373.00 ns (0.4%)
gen split merge : 751.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1333.00 ns (0.4%)
LB compute : 346.15 us (94.0%)
LB move op cnt : 0
LB apply : 3.45 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.26 us (71.5%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (7.371587578710185e-10,-2.9109326818167603e-09,-5.686736895579305e-10)
sum a = (2.1283902695537826e-11,1.489048777919516e-11,-1.785877816019671e-11)
sum e = 1.263274456031342e-10
sum de = 1.906777821401633e-15
Info: CFL hydro = 0.9089050714334144 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.9089050714334144 cfl multiplier : 0.9999999999999997 [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 | 2.9681e+05 | 99523 | 3.353e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 9811.67230073735 (tsim/hr) [sph::Model][rank=0]
---------------- t = 170.28365972881616, dt = 0.9089050714334144 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99523 min = 99523 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99523 min = 99523 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99523
max = 99523
avg = 99523
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.72 us (1.8%)
patch tree reduce : 1543.00 ns (0.4%)
gen split merge : 801.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1031.00 ns (0.3%)
LB compute : 351.86 us (94.4%)
LB move op cnt : 0
LB apply : 3.46 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.15 us (70.3%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (7.564151686252316e-10,-2.8970580981610254e-09,-5.848630890429155e-10)
sum a = (2.107885243388433e-11,1.5623743158809403e-11,-1.7747449505488516e-11)
sum e = 1.2632911300612193e-10
sum de = 1.974090565339521e-15
Info: CFL hydro = 0.9035924456682729 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.9035924456682729 cfl multiplier : 0.9999999999999997 [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 | 2.9453e+05 | 99523 | 3.379e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 9683.50674909697 (tsim/hr) [sph::Model][rank=0]
---------------- t = 171.19256480024958, dt = 0.9035924456682729 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99523 min = 99523 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99523 min = 99523 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99523
max = 99523
avg = 99523
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.01 us (1.8%)
patch tree reduce : 1543.00 ns (0.4%)
gen split merge : 912.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 982.00 ns (0.2%)
LB compute : 375.76 us (94.6%)
LB move op cnt : 0
LB apply : 3.89 us (1.0%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.33 us (69.3%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (7.753686748365074e-10,-2.8826073721030293e-09,-6.008489567565253e-10)
sum a = (2.0863146203063198e-11,1.6344141123376306e-11,-1.761850732875607e-11)
sum e = 1.2633082396706697e-10
sum de = 2.0401669856708985e-15
Info: CFL hydro = 0.8992741762368625 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.8992741762368625 cfl multiplier : 0.9999999999999997 [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 | 2.9739e+05 | 99523 | 3.347e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 9720.387049859895 (tsim/hr) [sph::Model][rank=0]
---------------- t = 172.09615724591785, dt = 0.8992741762368625 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99523 min = 99523 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99523 min = 99523 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99523
max = 99523
avg = 99523
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.00 us (1.6%)
patch tree reduce : 1453.00 ns (0.3%)
gen split merge : 741.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1131.00 ns (0.3%)
LB compute : 406.37 us (95.1%)
LB move op cnt : 0
LB apply : 3.38 us (0.8%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.36 us (71.7%)
central potential accretion : += 1e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (7.998073486648505e-10,-2.8627860721784143e-09,-6.230491347129397e-10)
sum a = (2.0577288784792918e-11,1.7290712883005646e-11,-1.7376733629825022e-11)
sum e = 1.26327701215284e-10
sum de = 2.0861720003063933e-15
Info: CFL hydro = 0.8961020946299036 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.8961020946299036 cfl multiplier : 0.9999999999999997 [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 | 2.9604e+05 | 99522 | 3.362e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 9629.949244403815 (tsim/hr) [sph::Model][rank=0]
---------------- t = 172.99543142215472, dt = 0.31737350570327294 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99522 min = 99522 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99522 min = 99522 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99522
max = 99522
avg = 99522
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.45 us (1.8%)
patch tree reduce : 1713.00 ns (0.4%)
gen split merge : 992.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1152.00 ns (0.3%)
LB compute : 382.24 us (94.1%)
LB move op cnt : 0
LB apply : 4.59 us (1.1%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.62 us (72.1%)
central potential accretion : += 3.0000000000000004e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010166862560970723 unconverged cnt = 1
Info: conservation infos : [sph::Model][rank=0]
sum v = (8.010422072635296e-10,-2.8657591042478077e-09,-6.263242583570292e-10)
sum a = (2.0645946683689243e-11,1.7408980307366215e-11,-1.747385694864886e-11)
sum e = 1.2630558566504588e-10
sum de = 2.0734265018114582e-15
Info: CFL hydro = 0.9052092260928781 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.9052092260928781 cfl multiplier : 0.9999999999999997 [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.9088e+05 | 99519 | 5.214e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 2191.393381379643 (tsim/hr) [sph::Model][rank=0]
Info: iteration since start : 129 [SPH][rank=0]
Info: time since start : 1413.8363095680002 (s) [SPH][rank=0]
Info: dump to _to_trash/black_hole_disc_lense_thirring_100000/dump/dump_0000007.vtk [VTK Dump][rank=0]
- took 8.05 ms, bandwidth = 660.37 MB/s
Info: Dumping state to _to_trash/black_hole_disc_lense_thirring_100000/dump/dump_0000007.sham [SPH][rank=0]
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 5.98 us (52.9%)
Info: dump to _to_trash/black_hole_disc_lense_thirring_100000/dump/dump_0000007.sham [Shamrock Dump][rank=0]
- took 11.19 ms, bandwidth = 1018.57 MB/s
Info: compute_column_integ field_name: rho, center: (0,0,0), delta_x: (1.1845115302733742,0,0), delta_y: (0,1.1845115302733742,0), nx: 1024, ny: 1024 [sph::CartesianRender][rank=0]
Info: compute_column_integ took 621.68 ms [sph::CartesianRender][rank=0]
Info: compute_column_integ field_name: vxyz, center: (0,0,0), delta_x: (1.1845115302733742,0,0), delta_y: (0,1.1845115302733742,0), nx: 1024, ny: 1024 [sph::CartesianRender][rank=0]
Info: compute_column_integ took 626.88 ms [sph::CartesianRender][rank=0]
---------------- t = 173.312804927858, dt = 0.9052092260928781 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99519 min = 99519 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99519 min = 99519 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99519
max = 99519
avg = 99519
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.49 us (1.7%)
patch tree reduce : 1303.00 ns (0.3%)
gen split merge : 771.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1012.00 ns (0.2%)
LB compute : 411.71 us (95.2%)
LB move op cnt : 0
LB apply : 3.22 us (0.7%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.69 us (74.7%)
central potential accretion : += 5e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010166823783549352 unconverged cnt = 4
Info: conservation infos : [sph::Model][rank=0]
sum v = (8.036102763322545e-10,-2.860761562550636e-09,-6.255827179235267e-10)
sum a = (2.053027342588249e-11,1.7484029695922213e-11,-1.749095493934824e-11)
sum e = 1.262903157401671e-10
sum de = 2.0696049294042426e-15
Info: CFL hydro = 0.9068429197321798 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.9068429197321798 cfl multiplier : 0.9999999999999997 [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.9171e+05 | 99514 | 5.191e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 6277.948791558345 (tsim/hr) [sph::Model][rank=0]
---------------- t = 174.21801415395086, dt = 0.9068429197321798 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99514 min = 99514 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99514 min = 99514 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99514
max = 99514
avg = 99514
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.77 us (2.0%)
patch tree reduce : 1633.00 ns (0.4%)
gen split merge : 831.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 982.00 ns (0.2%)
LB compute : 370.92 us (94.1%)
LB move op cnt : 0
LB apply : 4.11 us (1.0%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.33 us (69.8%)
central potential accretion : += 1e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (8.176648368010677e-10,-2.853472576181989e-09,-6.394430222133169e-10)
sum a = (2.042651637033393e-11,1.8064952368748702e-11,-1.7473500130109995e-11)
sum e = 1.2628712755223093e-10
sum de = 2.1247106285105656e-15
Info: CFL hydro = 0.9099344845843447 sink sink = inf [SPH][rank=0]
Info: cfl dt = 0.9099344845843447 cfl multiplier : 0.9999999999999997 [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 | 2.9768e+05 | 99513 | 3.343e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 9765.672497362575 (tsim/hr) [sph::Model][rank=0]
---------------- t = 175.12485707368305, dt = 0.9099344845843447 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99513 min = 99513 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99513 min = 99513 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99513
max = 99513
avg = 99513
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.37 us (1.6%)
patch tree reduce : 1332.00 ns (0.3%)
gen split merge : 732.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1012.00 ns (0.3%)
LB compute : 366.50 us (94.9%)
LB move op cnt : 0
LB apply : 3.61 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.40 us (71.6%)
central potential accretion : += 3.0000000000000004e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010166742473924129 unconverged cnt = 3
Info: conservation infos : [sph::Model][rank=0]
sum v = (8.302153826764078e-10,-2.842618600641934e-09,-6.497461874877624e-10)
sum a = (2.0251853467486563e-11,1.8547957732796998e-11,-1.739836134667549e-11)
sum e = 1.2627414992130785e-10
sum de = 2.1485364719764632e-15
Info: CFL hydro = 1.100103924858446 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.100103924858446 cfl multiplier : 0.9999999999999997 [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.9074e+05 | 99510 | 5.217e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 6278.9185662187265 (tsim/hr) [sph::Model][rank=0]
---------------- t = 176.0347915582674, dt = 1.100103924858446 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99510 min = 99510 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99510 min = 99510 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99510
max = 99510
avg = 99510
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.61 us (1.8%)
patch tree reduce : 1412.00 ns (0.4%)
gen split merge : 842.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1082.00 ns (0.3%)
LB compute : 344.17 us (94.4%)
LB move op cnt : 0
LB apply : 3.45 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.31 us (70.9%)
central potential accretion : += 3.0000000000000004e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010166690990484242 unconverged cnt = 2
Info: conservation infos : [sph::Model][rank=0]
sum v = (8.460711639714266e-10,-2.8238329796786223e-09,-6.604871859648504e-10)
sum a = (1.9927773548681725e-11,1.9093252869083103e-11,-1.7208015820026963e-11)
sum e = 1.2626581356581687e-10
sum de = 2.1764574367119484e-15
Info: CFL hydro = 1.100306161282249 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.100306161282249 cfl multiplier : 0.9999999999999997 [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.9251e+05 | 99507 | 5.169e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 7661.821787957237 (tsim/hr) [sph::Model][rank=0]
---------------- t = 177.13489548312583, dt = 1.100306161282249 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99507 min = 99507 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99507 min = 99507 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99507
max = 99507
avg = 99507
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.61 us (1.6%)
patch tree reduce : 1372.00 ns (0.3%)
gen split merge : 992.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1383.00 ns (0.3%)
LB compute : 381.41 us (94.5%)
LB move op cnt : 0
LB apply : 3.83 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.34 us (72.4%)
central potential accretion : += 3.0000000000000004e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.0101666378100774 unconverged cnt = 1
Info: conservation infos : [sph::Model][rank=0]
sum v = (8.747766390800188e-10,-2.8050575892341495e-09,-6.910707330793919e-10)
sum a = (1.9701587551707715e-11,2.028501602641572e-11,-1.6951779070298358e-11)
sum e = 1.2625323467936204e-10
sum de = 2.2083484684440598e-15
Info: CFL hydro = 1.1182929649784856 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.1182929649784856 cfl multiplier : 0.9999999999999997 [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.8801e+05 | 99504 | 5.292e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 7484.482415554663 (tsim/hr) [sph::Model][rank=0]
---------------- t = 178.23520164440808, dt = 1.1182929649784856 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99504 min = 99504 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99504 min = 99504 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99504
max = 99504
avg = 99504
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.36 us (2.0%)
patch tree reduce : 1332.00 ns (0.4%)
gen split merge : 1011.00 ns (0.3%)
split / merge op : 0/0
apply split merge : 982.00 ns (0.3%)
LB compute : 351.64 us (94.4%)
LB move op cnt : 0
LB apply : 3.33 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.25 us (69.7%)
central potential accretion : += 2e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010166582038741958 unconverged cnt = 1
Info: conservation infos : [sph::Model][rank=0]
sum v = (8.857471318427415e-10,-2.7947632106502107e-09,-6.992860541566628e-10)
sum a = (1.9517844245715953e-11,2.0687993128520932e-11,-1.689416063784599e-11)
sum e = 1.2624614357303617e-10
sum de = 2.251933145860792e-15
Info: CFL hydro = 1.1137849716723627 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.1137849716723627 cfl multiplier : 0.9999999999999997 [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.9282e+05 | 99502 | 5.160e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 7801.678457265893 (tsim/hr) [sph::Model][rank=0]
---------------- t = 179.35349460938656, dt = 1.1137849716723627 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99502 min = 99502 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99502 min = 99502 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99502
max = 99502
avg = 99502
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.36 us (1.7%)
patch tree reduce : 1603.00 ns (0.4%)
gen split merge : 691.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1233.00 ns (0.3%)
LB compute : 362.29 us (94.8%)
LB move op cnt : 0
LB apply : 3.48 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.44 us (71.3%)
central potential accretion : += 4e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010166524774967123 unconverged cnt = 4
Info: conservation infos : [sph::Model][rank=0]
sum v = (8.954110692381364e-10,-2.7813013944207866e-09,-7.042052373421859e-10)
sum a = (1.925387952582735e-11,2.100362565271377e-11,-1.680401731019757e-11)
sum e = 1.2622848003523848e-10
sum de = 2.265415987013746e-15
Info: CFL hydro = 1.1860813798426224 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.1860813798426224 cfl multiplier : 0.9999999999999997 [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.9222e+05 | 99498 | 5.176e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 7746.227382642473 (tsim/hr) [sph::Model][rank=0]
---------------- t = 180.46727958105893, dt = 1.1860813798426224 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99498 min = 99498 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99498 min = 99498 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99498
max = 99498
avg = 99498
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.78 us (1.8%)
patch tree reduce : 1292.00 ns (0.3%)
gen split merge : 762.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1052.00 ns (0.3%)
LB compute : 354.45 us (94.5%)
LB move op cnt : 0
LB apply : 3.48 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.46 us (71.2%)
central potential accretion : += 3.0000000000000004e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010166461918768967 unconverged cnt = 1
Info: conservation infos : [sph::Model][rank=0]
sum v = (9.205855206416468e-10,-2.7561522923299055e-09,-7.272249093235114e-10)
sum a = (1.8889823430677347e-11,2.1946945776975535e-11,-1.6461293057892588e-11)
sum e = 1.2621789421956614e-10
sum de = 2.3096455371115384e-15
Info: CFL hydro = 1.1667792969636783 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.1667792969636783 cfl multiplier : 0.9999999999999997 [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.9339e+05 | 99495 | 5.145e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 8299.622416869111 (tsim/hr) [sph::Model][rank=0]
---------------- t = 181.65336096090155, dt = 1.1667792969636783 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99495 min = 99495 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99495 min = 99495 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99495
max = 99495
avg = 99495
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.52 us (1.9%)
patch tree reduce : 1413.00 ns (0.4%)
gen split merge : 721.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 993.00 ns (0.3%)
LB compute : 331.27 us (94.3%)
LB move op cnt : 0
LB apply : 3.35 us (1.0%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.12 us (68.8%)
central potential accretion : += 5e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010166398207220578 unconverged cnt = 5
Info: conservation infos : [sph::Model][rank=0]
sum v = (9.497809024011081e-10,-2.722168557755449e-09,-7.539810303185382e-10)
sum a = (1.8389122280370036e-11,2.3020320207548374e-11,-1.5931965463109177e-11)
sum e = 1.2619479434746939e-10
sum de = 2.331144703758453e-15
Info: CFL hydro = 1.1514721989469685 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.1514721989469685 cfl multiplier : 0.9999999999999997 [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.9349e+05 | 99490 | 5.142e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 8168.96491449354 (tsim/hr) [sph::Model][rank=0]
---------------- t = 182.82014025786523, dt = 1.1514721989469685 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99490 min = 99490 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99490 min = 99490 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99490
max = 99490
avg = 99490
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.35 us (2.1%)
patch tree reduce : 1713.00 ns (0.5%)
gen split merge : 742.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1102.00 ns (0.3%)
LB compute : 336.20 us (93.9%)
LB move op cnt : 0
LB apply : 3.70 us (1.0%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.17 us (69.1%)
central potential accretion : += 5e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010166333514222366 unconverged cnt = 3
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010166333514222366 unconverged cnt = 2
Info: conservation infos : [sph::Model][rank=0]
sum v = (9.787766523814625e-10,-2.6997597945476284e-09,-7.864609893860307e-10)
sum a = (1.8149657905890346e-11,2.4228610549934133e-11,-1.553368676920643e-11)
sum e = 1.2617182022873413e-10
sum de = 2.337661525963086e-15
Info: CFL hydro = 1.1393694541658657 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.1393694541658657 cfl multiplier : 0.9999999999999997 [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.4234e+05 | 99485 | 6.989e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 5930.8787878967305 (tsim/hr) [sph::Model][rank=0]
---------------- t = 183.9716124568122, dt = 1.1393694541658657 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99485 min = 99485 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99485 min = 99485 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99485
max = 99485
avg = 99485
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.86 us (1.9%)
patch tree reduce : 1392.00 ns (0.4%)
gen split merge : 802.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1253.00 ns (0.4%)
LB compute : 332.84 us (94.1%)
LB move op cnt : 0
LB apply : 3.44 us (1.0%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.30 us (69.5%)
central potential accretion : += 3.0000000000000004e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.0101662677330478 unconverged cnt = 4
Info: conservation infos : [sph::Model][rank=0]
sum v = (1.0014392548250222e-09,-2.660498984775961e-09,-8.023150982382989e-10)
sum a = (1.7529328653141785e-11,2.4952673885945197e-11,-1.488750072408633e-11)
sum e = 1.261590473427802e-10
sum de = 2.3739377161895116e-15
Info: CFL hydro = 1.1300049595275286 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.1300049595275286 cfl multiplier : 0.9999999999999997 [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.9438e+05 | 99482 | 5.118e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 8014.657078069534 (tsim/hr) [sph::Model][rank=0]
---------------- t = 185.11098191097807, dt = 1.1300049595275286 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99482 min = 99482 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99482 min = 99482 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99482
max = 99482
avg = 99482
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.95 us (2.0%)
patch tree reduce : 1232.00 ns (0.4%)
gen split merge : 752.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1002.00 ns (0.3%)
LB compute : 326.69 us (94.1%)
LB move op cnt : 0
LB apply : 3.76 us (1.1%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.16 us (70.1%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (1.0209976762728465e-09,-2.631897631877093e-09,-8.188856053636731e-10)
sum a = (1.7082442482997863e-11,2.5629919864711866e-11,-1.4425531217355226e-11)
sum e = 1.261615399609823e-10
sum de = 2.437390803455575e-15
Info: CFL hydro = 1.1230935753406381 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.1230935753406381 cfl multiplier : 0.9999999999999997 [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 | 2.9058e+05 | 99482 | 3.424e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 11882.350485041823 (tsim/hr) [sph::Model][rank=0]
---------------- t = 186.2409868705056, dt = 1.1230935753406381 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99482 min = 99482 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99482 min = 99482 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99482
max = 99482
avg = 99482
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.06 us (1.5%)
patch tree reduce : 1503.00 ns (0.3%)
gen split merge : 771.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1342.00 ns (0.3%)
LB compute : 446.16 us (95.5%)
LB move op cnt : 0
LB apply : 3.26 us (0.7%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.18 us (71.0%)
central potential accretion : += 7e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010166132504853247 unconverged cnt = 6
Info: conservation infos : [sph::Model][rank=0]
sum v = (1.039849684230633e-09,-2.5838108454446335e-09,-8.273277378924615e-10)
sum a = (1.6282746204802423e-11,2.61231441423543e-11,-1.3643723741922308e-11)
sum e = 1.2612890362013185e-10
sum de = 2.423872079225634e-15
Info: CFL hydro = 1.1183206783138684 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.1183206783138684 cfl multiplier : 0.9999999999999997 [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.7022e+05 | 99475 | 5.844e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 6918.7480211327265 (tsim/hr) [sph::Model][rank=0]
---------------- t = 187.36408044584624, dt = 1.1183206783138684 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99475 min = 99475 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99475 min = 99475 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99475
max = 99475
avg = 99475
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.35 us (1.7%)
patch tree reduce : 1512.00 ns (0.4%)
gen split merge : 711.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1202.00 ns (0.3%)
LB compute : 351.84 us (94.6%)
LB move op cnt : 0
LB apply : 3.22 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.50 us (71.9%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (1.057807077880055e-09,-2.55424085463834e-09,-8.423169285905337e-10)
sum a = (1.582553200725217e-11,2.6724862703081873e-11,-1.3145883914681125e-11)
sum e = 1.2613153749309395e-10
sum de = 2.483799905513776e-15
Info: CFL hydro = 1.1154643659960417 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.1154643659960417 cfl multiplier : 0.9999999999999997 [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.0143e+05 | 99475 | 3.300e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 12199.580282811366 (tsim/hr) [sph::Model][rank=0]
---------------- t = 188.4824011241601, dt = 1.1154643659960417 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99475 min = 99475 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99475 min = 99475 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99475
max = 99475
avg = 99475
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.47 us (2.0%)
patch tree reduce : 1402.00 ns (0.4%)
gen split merge : 881.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1272.00 ns (0.3%)
LB compute : 353.48 us (94.2%)
LB move op cnt : 0
LB apply : 3.25 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.25 us (69.9%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (1.0752042388612873e-09,-2.5240937654524387e-09,-8.567023213702357e-10)
sum a = (1.5361222020504286e-11,2.7295893383479045e-11,-1.2630052256372664e-11)
sum e = 1.2613427693106444e-10
sum de = 2.541407214997886e-15
Info: CFL hydro = 1.3264469736032465 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.3264469736032465 cfl multiplier : 0.9999999999999997 [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 | 2.9565e+05 | 99475 | 3.365e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 11934.919701563234 (tsim/hr) [sph::Model][rank=0]
---------------- t = 189.59786549015615, dt = 1.3264469736032465 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99475 min = 99475 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99475 min = 99475 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99475
max = 99475
avg = 99475
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.80 us (1.9%)
patch tree reduce : 1693.00 ns (0.5%)
gen split merge : 802.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1213.00 ns (0.3%)
LB compute : 344.69 us (94.3%)
LB move op cnt : 0
LB apply : 3.51 us (1.0%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.24 us (70.7%)
central potential accretion : += 2e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010165905018617409 unconverged cnt = 2
Info: conservation infos : [sph::Model][rank=0]
sum v = (1.083433260299428e-09,-2.4951768813802962e-09,-8.587431967618494e-10)
sum a = (1.4831591145672076e-11,2.743437737037616e-11,-1.2208384565151237e-11)
sum e = 1.2613313104812184e-10
sum de = 2.587151147727947e-15
Info: CFL hydro = 1.3346248161088419 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.3346248161088419 cfl multiplier : 0.9999999999999997 [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.9491e+05 | 99473 | 5.104e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 9356.533525703768 (tsim/hr) [sph::Model][rank=0]
---------------- t = 190.9243124637594, dt = 1.3346248161088419 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99473 min = 99473 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99473 min = 99473 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99473
max = 99473
avg = 99473
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.85 us (1.7%)
patch tree reduce : 1533.00 ns (0.4%)
gen split merge : 822.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1002.00 ns (0.3%)
LB compute : 376.89 us (94.9%)
LB move op cnt : 0
LB apply : 3.43 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.40 us (71.4%)
central potential accretion : += 2e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (1.1131785054948355e-09,-2.4460443994137578e-09,-8.851749461036727e-10)
sum a = (1.4160699596427065e-11,2.8438702356420563e-11,-1.1270247302179598e-11)
sum e = 1.2612681145916536e-10
sum de = 2.6220990283606977e-15
Info: CFL hydro = 1.634761729792689 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.634761729792689 cfl multiplier : 0.9999999999999997 [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 | 2.9264e+05 | 99471 | 3.399e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 14135.04213328666 (tsim/hr) [sph::Model][rank=0]
---------------- t = 192.25893727986823, dt = 1.634761729792689 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99471 min = 99471 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99471 min = 99471 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99471
max = 99471
avg = 99471
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.06 us (1.9%)
patch tree reduce : 1383.00 ns (0.4%)
gen split merge : 751.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1082.00 ns (0.3%)
LB compute : 360.94 us (94.7%)
LB move op cnt : 0
LB apply : 3.40 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.25 us (71.6%)
central potential accretion : += 5e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010165702507655867 unconverged cnt = 2
Info: conservation infos : [sph::Model][rank=0]
sum v = (1.147898179197293e-09,-2.383279204829806e-09,-9.146919542370213e-10)
sum a = (1.3305809680492944e-11,2.9559621987796935e-11,-1.008802779401729e-11)
sum e = 1.261154473344254e-10
sum de = 2.6412491633249282e-15
Info: CFL hydro = 1.6132815230958986 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.6132815230958986 cfl multiplier : 0.9999999999999997 [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.9419e+05 | 99466 | 5.122e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 11489.81317430296 (tsim/hr) [sph::Model][rank=0]
---------------- t = 193.89369900966093, dt = 1.6132815230958986 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99466 min = 99466 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99466 min = 99466 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99466
max = 99466
avg = 99466
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.59 us (1.9%)
patch tree reduce : 1904.00 ns (0.5%)
gen split merge : 1072.00 ns (0.3%)
split / merge op : 0/0
apply split merge : 1332.00 ns (0.3%)
LB compute : 378.45 us (93.6%)
LB move op cnt : 0
LB apply : 4.38 us (1.1%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.47 us (72.0%)
central potential accretion : += 1e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (1.1626073164091004e-09,-2.336440868018392e-09,-9.223210829554479e-10)
sum a = (1.2557769788480421e-11,2.9866713844458715e-11,-9.26743995902264e-12)
sum e = 1.2611385876625484e-10
sum de = 2.699104705618376e-15
Info: CFL hydro = 1.580792987162466 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.580792987162466 cfl multiplier : 0.9999999999999997 [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 | 2.9885e+05 | 99465 | 3.328e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 17449.745329779256 (tsim/hr) [sph::Model][rank=0]
---------------- t = 195.50698053275684, dt = 1.580792987162466 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99465 min = 99465 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99465 min = 99465 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99465
max = 99465
avg = 99465
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.21 us (1.7%)
patch tree reduce : 1383.00 ns (0.4%)
gen split merge : 701.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1052.00 ns (0.3%)
LB compute : 352.94 us (94.8%)
LB move op cnt : 0
LB apply : 3.26 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.33 us (70.1%)
central potential accretion : += 2e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (1.1819681140378905e-09,-2.297970039535802e-09,-9.391575586057635e-10)
sum a = (1.200449232686644e-11,3.046128904263509e-11,-8.588263013227901e-12)
sum e = 1.2610683973271057e-10
sum de = 2.7439921287812583e-15
Info: CFL hydro = 1.5593709769813997 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.5593709769813997 cfl multiplier : 0.9999999999999997 [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 | 2.9952e+05 | 99463 | 3.321e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 17137.524734361217 (tsim/hr) [sph::Model][rank=0]
---------------- t = 197.0877735199193, dt = 0.9840035404898515 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99463 min = 99463 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99463 min = 99463 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99463
max = 99463
avg = 99463
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.50 us (1.9%)
patch tree reduce : 1753.00 ns (0.5%)
gen split merge : 811.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1192.00 ns (0.3%)
LB compute : 330.42 us (94.2%)
LB move op cnt : 0
LB apply : 3.53 us (1.0%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.29 us (70.6%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (1.193220215391439e-09,-2.2675891027871393e-09,-9.469144274923992e-10)
sum a = (1.1565389332310503e-11,3.075011540688932e-11,-8.022626112486252e-12)
sum e = 1.2609284484898167e-10
sum de = 2.7863838243249294e-15
Info: CFL hydro = 1.61324488446626 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.61324488446626 cfl multiplier : 0.9999999999999997 [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.0326e+05 | 99463 | 3.280e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 10800.750424327392 (tsim/hr) [sph::Model][rank=0]
Info: iteration since start : 150 [SPH][rank=0]
Info: time since start : 1424.91368654 (s) [SPH][rank=0]
Info: dump to _to_trash/black_hole_disc_lense_thirring_100000/dump/dump_0000008.vtk [VTK Dump][rank=0]
- took 7.78 ms, bandwidth = 682.59 MB/s
Info: Dumping state to _to_trash/black_hole_disc_lense_thirring_100000/dump/dump_0000008.sham [SPH][rank=0]
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.38 us (55.8%)
Info: dump to _to_trash/black_hole_disc_lense_thirring_100000/dump/dump_0000008.sham [Shamrock Dump][rank=0]
- took 11.46 ms, bandwidth = 993.85 MB/s
Info: compute_column_integ field_name: rho, center: (0,0,0), delta_x: (1.1845115302733742,0,0), delta_y: (0,1.1845115302733742,0), nx: 1024, ny: 1024 [sph::CartesianRender][rank=0]
Info: compute_column_integ took 621.78 ms [sph::CartesianRender][rank=0]
Info: compute_column_integ field_name: vxyz, center: (0,0,0), delta_x: (1.1845115302733742,0,0), delta_y: (0,1.1845115302733742,0), nx: 1024, ny: 1024 [sph::CartesianRender][rank=0]
Info: compute_column_integ took 626.49 ms [sph::CartesianRender][rank=0]
---------------- t = 198.07177706040915, dt = 1.61324488446626 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99463 min = 99463 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99463 min = 99463 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99463
max = 99463
avg = 99463
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.08 us (1.5%)
patch tree reduce : 1563.00 ns (0.3%)
gen split merge : 841.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1072.00 ns (0.2%)
LB compute : 437.37 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.56 us (69.7%)
central potential accretion : += 2e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010165274691448447 unconverged cnt = 1
Info: conservation infos : [sph::Model][rank=0]
sum v = (1.2018214355103328e-09,-2.2282405211126137e-09,-9.496218989972102e-10)
sum a = (1.0908461974587816e-11,3.079902707803257e-11,-7.34216661255226e-12)
sum e = 1.261049655375724e-10
sum de = 2.81224553290267e-15
Info: CFL hydro = 1.6326995209429733 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.6326995209429733 cfl multiplier : 0.9999999999999997 [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.9487e+05 | 99461 | 5.104e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 11378.755154083876 (tsim/hr) [sph::Model][rank=0]
---------------- t = 199.68502194487542, dt = 1.6326995209429733 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99461 min = 99461 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99461 min = 99461 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99461
max = 99461
avg = 99461
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.69 us (1.6%)
patch tree reduce : 1393.00 ns (0.3%)
gen split merge : 721.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1022.00 ns (0.2%)
LB compute : 403.65 us (95.2%)
LB move op cnt : 0
LB apply : 3.58 us (0.8%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.48 us (72.5%)
central potential accretion : += 1e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010165146353640528 unconverged cnt = 1
Info: conservation infos : [sph::Model][rank=0]
sum v = (1.2222452561862887e-09,-2.168227912121489e-09,-9.624404871559094e-10)
sum a = (1.0067144545318901e-11,3.1249717035668416e-11,-6.189018866769459e-12)
sum e = 1.2610526151403724e-10
sum de = 2.8465274873860697e-15
Info: CFL hydro = 1.648658394463438 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.648658394463438 cfl multiplier : 0.9999999999999997 [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.9493e+05 | 99460 | 5.102e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 11519.521225662083 (tsim/hr) [sph::Model][rank=0]
---------------- t = 201.31772146581838, dt = 1.648658394463438 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99460 min = 99460 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99460 min = 99460 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99460
max = 99460
avg = 99460
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.86 us (1.4%)
patch tree reduce : 1433.00 ns (0.3%)
gen split merge : 721.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 982.00 ns (0.2%)
LB compute : 457.47 us (95.6%)
LB move op cnt : 0
LB apply : 3.62 us (0.8%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.52 us (68.8%)
central potential accretion : += 4e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (1.2365994440071342e-09,-2.1136131576910057e-09,-9.681145681277176e-10)
sum a = (9.276425228515171e-12,3.1443917740854004e-11,-5.161518524926447e-12)
sum e = 1.2609012967686095e-10
sum de = 2.849952171916845e-15
Info: CFL hydro = 1.6146656752263533 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.6146656752263533 cfl multiplier : 0.9999999999999997 [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 | 2.9213e+05 | 99456 | 3.405e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 17432.984448474366 (tsim/hr) [sph::Model][rank=0]
---------------- t = 202.96637986028182, dt = 1.6146656752263533 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99456 min = 99456 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99456 min = 99456 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99456
max = 99456
avg = 99456
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.00 us (1.9%)
patch tree reduce : 1332.00 ns (0.4%)
gen split merge : 691.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 982.00 ns (0.3%)
LB compute : 349.75 us (94.4%)
LB move op cnt : 0
LB apply : 3.29 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.23 us (69.7%)
central potential accretion : += 1e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (1.2544094163954886e-09,-2.0533464625677093e-09,-9.774835248787813e-10)
sum a = (8.455760168594433e-12,3.174915031882926e-11,-3.986931512561397e-12)
sum e = 1.2608849805098245e-10
sum de = 2.8726285586829827e-15
Info: CFL hydro = 1.6107295267920247 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.6107295267920247 cfl multiplier : 0.9999999999999997 [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 | 2.9986e+05 | 99455 | 3.317e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 17525.70924598614 (tsim/hr) [sph::Model][rank=0]
---------------- t = 204.58104553550817, dt = 1.6107295267920247 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99455 min = 99455 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99455 min = 99455 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99455
max = 99455
avg = 99455
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.58 us (1.7%)
patch tree reduce : 1362.00 ns (0.3%)
gen split merge : 671.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 982.00 ns (0.3%)
LB compute : 371.15 us (94.9%)
LB move op cnt : 0
LB apply : 3.27 us (0.8%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.58 us (70.1%)
central potential accretion : += 3.0000000000000004e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.01016474339760544 unconverged cnt = 3
Info: conservation infos : [sph::Model][rank=0]
sum v = (1.2602206387186935e-09,-1.9997172350155584e-09,-9.726329131657986e-10)
sum a = (7.662555638519296e-12,3.1528158646948074e-11,-2.9963409191735892e-12)
sum e = 1.2607766085386136e-10
sum de = 2.880070644251169e-15
Info: CFL hydro = 1.572220884858006 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.572220884858006 cfl multiplier : 0.9999999999999997 [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.9458e+05 | 99452 | 5.111e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 11345.396254894145 (tsim/hr) [sph::Model][rank=0]
---------------- t = 206.1917750623002, dt = 1.572220884858006 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99452 min = 99452 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99452 min = 99452 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99452
max = 99452
avg = 99452
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.42 us (1.4%)
patch tree reduce : 1382.00 ns (0.3%)
gen split merge : 1052.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 991.00 ns (0.2%)
LB compute : 426.77 us (95.5%)
LB move op cnt : 0
LB apply : 3.53 us (0.8%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.33 us (71.3%)
central potential accretion : += 5e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010164607161124136 unconverged cnt = 3
Info: conservation infos : [sph::Model][rank=0]
sum v = (1.2740036897134332e-09,-1.9673185617190968e-09,-9.86755536686409e-10)
sum a = (7.275315324713227e-12,3.186421768624314e-11,-2.4120834498097036e-12)
sum e = 1.2605526607382232e-10
sum de = 2.8629089712438988e-15
Info: CFL hydro = 1.540709889108348 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.540709889108348 cfl multiplier : 0.9999999999999997 [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.9553e+05 | 99447 | 5.086e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 11128.572360519021 (tsim/hr) [sph::Model][rank=0]
---------------- t = 207.7639959471582, dt = 1.540709889108348 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99447 min = 99447 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99447 min = 99447 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99447
max = 99447
avg = 99447
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.23 us (1.8%)
patch tree reduce : 1723.00 ns (0.4%)
gen split merge : 801.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1273.00 ns (0.3%)
LB compute : 379.75 us (94.3%)
LB move op cnt : 0
LB apply : 4.21 us (1.0%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.45 us (70.6%)
central potential accretion : += 3.0000000000000004e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010164470734420743 unconverged cnt = 3
Info: conservation infos : [sph::Model][rank=0]
sum v = (1.2890185983065015e-09,-1.909027123603427e-09,-9.928515040550102e-10)
sum a = (6.531407531786437e-12,3.201927402878696e-11,-1.2598859667786166e-12)
sum e = 1.2604330710822238e-10
sum de = 2.8606329657487784e-15
Info: CFL hydro = 1.4948126158183244 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.4948126158183244 cfl multiplier : 0.9999999999999997 [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.9582e+05 | 99444 | 5.078e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 10922.183292700822 (tsim/hr) [sph::Model][rank=0]
---------------- t = 209.30470583626655, dt = 1.4948126158183244 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99444 min = 99444 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99444 min = 99444 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99444
max = 99444
avg = 99444
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 9.50 us (2.2%)
patch tree reduce : 2.38 us (0.6%)
gen split merge : 881.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1372.00 ns (0.3%)
LB compute : 394.57 us (93.4%)
LB move op cnt : 0
LB apply : 5.17 us (1.2%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.24 us (70.2%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (1.2982671112930074e-09,-1.8611494819166988e-09,-9.940061099343601e-10)
sum a = (5.8895396166075735e-12,3.1981836795543373e-11,-3.422105842124131e-13)
sum e = 1.2604609429182674e-10
sum de = 2.8760509001786574e-15
Info: CFL hydro = 1.4512622199942575 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.4512622199942575 cfl multiplier : 0.9999999999999997 [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.0155e+05 | 99444 | 3.298e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 16318.067941105506 (tsim/hr) [sph::Model][rank=0]
---------------- t = 210.79951845208487, dt = 1.4512622199942575 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99444 min = 99444 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99444 min = 99444 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99444
max = 99444
avg = 99444
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.89 us (1.9%)
patch tree reduce : 1463.00 ns (0.4%)
gen split merge : 902.00 ns (0.3%)
split / merge op : 0/0
apply split merge : 1122.00 ns (0.3%)
LB compute : 335.43 us (94.0%)
LB move op cnt : 0
LB apply : 3.69 us (1.0%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.71 us (68.6%)
central potential accretion : += 5e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010164201899762146 unconverged cnt = 5
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010164201899762146 unconverged cnt = 1
Info: conservation infos : [sph::Model][rank=0]
sum v = (1.317759761021028e-09,-1.8238902213022473e-09,-1.0110622185567785e-09)
sum a = (5.485966295226464e-12,3.247988244899853e-11,4.3883731973103393e-13)
sum e = 1.2602324582195945e-10
sum de = 2.8373885203681042e-15
Info: CFL hydro = 1.416363643768853 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.416363643768853 cfl multiplier : 0.9999999999999997 [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.4519e+05 | 99439 | 6.849e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 7628.310759709004 (tsim/hr) [sph::Model][rank=0]
---------------- t = 212.25078067207912, dt = 1.416363643768853 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99439 min = 99439 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99439 min = 99439 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99439
max = 99439
avg = 99439
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.85 us (1.9%)
patch tree reduce : 1532.00 ns (0.4%)
gen split merge : 781.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1303.00 ns (0.4%)
LB compute : 336.16 us (94.1%)
LB move op cnt : 0
LB apply : 3.27 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.50 us (69.3%)
central potential accretion : += 1e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (1.3286236219708417e-09,-1.7686739703934652e-09,-1.0114336730817986e-09)
sum a = (4.790035429986613e-12,3.2439992042771876e-11,1.5292804843069156e-12)
sum e = 1.2602110086310505e-10
sum de = 2.828405865154979e-15
Info: CFL hydro = 1.3880696165841229 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.3880696165841229 cfl multiplier : 0.9999999999999997 [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.0149e+05 | 99438 | 3.298e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 15459.372363847293 (tsim/hr) [sph::Model][rank=0]
---------------- t = 213.66714431584796, dt = 1.3880696165841229 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99438 min = 99438 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99438 min = 99438 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99438
max = 99438
avg = 99438
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.65 us (1.6%)
patch tree reduce : 1373.00 ns (0.3%)
gen split merge : 781.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 991.00 ns (0.2%)
LB compute : 408.55 us (95.3%)
LB move op cnt : 0
LB apply : 3.44 us (0.8%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.42 us (71.5%)
central potential accretion : += 4e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (1.3485229360904387e-09,-1.7262464505406657e-09,-1.0278488069407929e-09)
sum a = (4.384187754856889e-12,3.289317930664222e-11,2.404115285530361e-12)
sum e = 1.260036256745413e-10
sum de = 2.797726390746953e-15
Info: CFL hydro = 1.4795888809934694 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.4795888809934694 cfl multiplier : 0.9999999999999997 [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.0196e+05 | 99434 | 3.293e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 15175.201651857999 (tsim/hr) [sph::Model][rank=0]
---------------- t = 215.05521393243208, dt = 1.4795888809934694 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99434 min = 99434 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99434 min = 99434 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99434
max = 99434
avg = 99434
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.64 us (1.9%)
patch tree reduce : 1323.00 ns (0.4%)
gen split merge : 881.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1002.00 ns (0.3%)
LB compute : 336.24 us (94.4%)
LB move op cnt : 0
LB apply : 3.15 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.22 us (70.5%)
central potential accretion : += 4e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (1.351971602437237e-09,-1.6844180331459389e-09,-1.0229249058215077e-09)
sum a = (3.830901391398353e-12,3.263385775747827e-11,3.175833301376323e-12)
sum e = 1.2599006767866965e-10
sum de = 2.7728407373459593e-15
Info: CFL hydro = 1.4497051578930558 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.4497051578930558 cfl multiplier : 0.9999999999999997 [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.0147e+05 | 99430 | 3.298e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 16150.045887687194 (tsim/hr) [sph::Model][rank=0]
---------------- t = 216.53480281342556, dt = 1.4497051578930558 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99430 min = 99430 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99430 min = 99430 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99430
max = 99430
avg = 99430
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.69 us (1.8%)
patch tree reduce : 1323.00 ns (0.4%)
gen split merge : 591.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 992.00 ns (0.3%)
LB compute : 349.50 us (94.5%)
LB move op cnt : 0
LB apply : 3.37 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.44 us (69.2%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (1.3570553111172611e-09,-1.6372798202310828e-09,-1.0176342366058079e-09)
sum a = (3.2245913998686658e-12,3.235962037367746e-11,4.0738565950517355e-12)
sum e = 1.2599314366700914e-10
sum de = 2.768220431361122e-15
Info: CFL hydro = 1.426871940957403 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.426871940957403 cfl multiplier : 0.9999999999999997 [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.0374e+05 | 99430 | 3.274e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 15942.632900256394 (tsim/hr) [sph::Model][rank=0]
---------------- t = 217.9845079713186, dt = 1.426871940957403 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99430 min = 99430 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99430 min = 99430 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99430
max = 99430
avg = 99430
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.92 us (1.9%)
patch tree reduce : 1623.00 ns (0.4%)
gen split merge : 1142.00 ns (0.3%)
split / merge op : 0/0
apply split merge : 1502.00 ns (0.4%)
LB compute : 388.46 us (93.9%)
LB move op cnt : 0
LB apply : 4.60 us (1.1%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.17 us (70.2%)
central potential accretion : += 3.0000000000000004e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (1.3483847168465038e-09,-1.612648668236653e-09,-1.0022510789365317e-09)
sum a = (2.8142141397835536e-12,3.167086109449882e-11,4.405255895250151e-12)
sum e = 1.259810058466718e-10
sum de = 2.7431869680461115e-15
Info: CFL hydro = 1.636760670823507 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.636760670823507 cfl multiplier : 0.9999999999999997 [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.0188e+05 | 99427 | 3.294e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 15596.126486339093 (tsim/hr) [sph::Model][rank=0]
---------------- t = 219.411379912276, dt = 1.636760670823507 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99427 min = 99427 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99427 min = 99427 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99427
max = 99427
avg = 99427
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.41 us (2.0%)
patch tree reduce : 1563.00 ns (0.4%)
gen split merge : 1092.00 ns (0.3%)
split / merge op : 0/0
apply split merge : 1132.00 ns (0.3%)
LB compute : 350.69 us (93.9%)
LB move op cnt : 0
LB apply : 4.00 us (1.1%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.40 us (70.4%)
central potential accretion : += 1e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (1.3530973317208787e-09,-1.5700606425104466e-09,-9.989529811596011e-10)
sum a = (2.285487497191589e-12,3.138655652765685e-11,5.165465287657828e-12)
sum e = 1.2598732849242608e-10
sum de = 2.720411252642621e-15
Info: CFL hydro = 1.6143249658681929 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.6143249658681929 cfl multiplier : 0.9999999999999997 [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.0097e+05 | 99426 | 3.303e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 17836.7488063365 (tsim/hr) [sph::Model][rank=0]
---------------- t = 221.04814058309952, dt = 1.6143249658681929 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99426 min = 99426 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99426 min = 99426 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99426
max = 99426
avg = 99426
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.89 us (1.8%)
patch tree reduce : 1352.00 ns (0.4%)
gen split merge : 771.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1133.00 ns (0.3%)
LB compute : 363.95 us (94.6%)
LB move op cnt : 0
LB apply : 3.35 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.29 us (71.1%)
central potential accretion : += 1e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (1.3621632502936135e-09,-1.5127363804937421e-09,-9.94232873802187e-10)
sum a = (1.612084246826312e-12,3.1135944040172834e-11,6.289519781441817e-12)
sum e = 1.259857689977032e-10
sum de = 2.688943456460677e-15
Info: CFL hydro = 1.556271777951176 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.556271777951176 cfl multiplier : 0.9999999999999997 [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 | 2.9695e+05 | 99425 | 3.348e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 17357.328750500586 (tsim/hr) [sph::Model][rank=0]
---------------- t = 222.66246554896773, dt = 0.16828364399256657 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99425 min = 99425 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99425 min = 99425 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99425
max = 99425
avg = 99425
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.18 us (1.9%)
patch tree reduce : 1683.00 ns (0.4%)
gen split merge : 781.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1072.00 ns (0.3%)
LB compute : 361.45 us (94.3%)
LB move op cnt : 0
LB apply : 3.99 us (1.0%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.46 us (71.4%)
central potential accretion : += 1e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (1.368006599637638e-09,-1.5014586831424401e-09,-9.973721125203785e-10)
sum a = (1.5149792027778737e-12,3.127608235004984e-11,6.571680627400331e-12)
sum e = 1.2595314092720367e-10
sum de = 2.6865162842895187e-15
Info: CFL hydro = 1.5575581500904672 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.5575581500904672 cfl multiplier : 0.9999999999999997 [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.0833e+05 | 99424 | 3.225e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 1878.737584865367 (tsim/hr) [sph::Model][rank=0]
Info: iteration since start : 167 [SPH][rank=0]
Info: time since start : 1433.178821417 (s) [SPH][rank=0]
Info: dump to _to_trash/black_hole_disc_lense_thirring_100000/dump/dump_0000009.vtk [VTK Dump][rank=0]
- took 7.74 ms, bandwidth = 685.73 MB/s
Info: Dumping state to _to_trash/black_hole_disc_lense_thirring_100000/dump/dump_0000009.sham [SPH][rank=0]
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.11 us (53.1%)
Info: dump to _to_trash/black_hole_disc_lense_thirring_100000/dump/dump_0000009.sham [Shamrock Dump][rank=0]
- took 11.05 ms, bandwidth = 1.01 GB/s
Info: compute_column_integ field_name: rho, center: (0,0,0), delta_x: (1.1845115302733742,0,0), delta_y: (0,1.1845115302733742,0), nx: 1024, ny: 1024 [sph::CartesianRender][rank=0]
Info: compute_column_integ took 626.77 ms [sph::CartesianRender][rank=0]
Info: compute_column_integ field_name: vxyz, center: (0,0,0), delta_x: (1.1845115302733742,0,0), delta_y: (0,1.1845115302733742,0), nx: 1024, ny: 1024 [sph::CartesianRender][rank=0]
Info: compute_column_integ took 627.22 ms [sph::CartesianRender][rank=0]
---------------- t = 222.8307491929603, dt = 1.5575581500904672 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99424 min = 99424 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99424 min = 99424 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99424
max = 99424
avg = 99424
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.43 us (1.7%)
patch tree reduce : 1463.00 ns (0.3%)
gen split merge : 812.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 992.00 ns (0.2%)
LB compute : 412.50 us (95.0%)
LB move op cnt : 0
LB apply : 3.68 us (0.8%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.42 us (71.4%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (1.3703619210196294e-09,-1.45274882355238e-09,-9.871283147122259e-10)
sum a = (9.13277802066944e-13,3.0797003771678766e-11,7.456515157767416e-12)
sum e = 1.2598329648686285e-10
sum de = 2.6550825372502897e-15
Info: CFL hydro = 1.4500202464836673 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.4500202464836673 cfl multiplier : 0.9999999999999997 [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.0263e+05 | 99424 | 3.285e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 17067.480243791957 (tsim/hr) [sph::Model][rank=0]
---------------- t = 224.38830734305077, dt = 1.4500202464836673 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99424 min = 99424 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99424 min = 99424 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99424
max = 99424
avg = 99424
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.41 us (1.7%)
patch tree reduce : 1362.00 ns (0.4%)
gen split merge : 692.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1032.00 ns (0.3%)
LB compute : 349.52 us (94.7%)
LB move op cnt : 0
LB apply : 3.82 us (1.0%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.35 us (70.9%)
central potential accretion : += 3.0000000000000004e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010162831031741341 unconverged cnt = 1
Info: conservation infos : [sph::Model][rank=0]
sum v = (1.3871846365355618e-09,-1.395689250505191e-09,-9.90937834465983e-10)
sum a = (3.4785202775003074e-13,3.089402456431183e-11,8.622172905164441e-12)
sum e = 1.2596821478632476e-10
sum de = 2.596151525050477e-15
Info: CFL hydro = 1.4532680865000944 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.4532680865000944 cfl multiplier : 0.9999999999999997 [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.9660e+05 | 99421 | 5.057e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 10322.61324351984 (tsim/hr) [sph::Model][rank=0]
---------------- t = 225.83832758953443, dt = 1.4532680865000944 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99421 min = 99421 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99421 min = 99421 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99421
max = 99421
avg = 99421
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.49 us (2.0%)
patch tree reduce : 1593.00 ns (0.4%)
gen split merge : 991.00 ns (0.3%)
split / merge op : 0/0
apply split merge : 1273.00 ns (0.3%)
LB compute : 359.35 us (94.2%)
LB move op cnt : 0
LB apply : 3.51 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.29 us (70.4%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (1.3872936283492923e-09,-1.3511583460079385e-09,-9.778144585950784e-10)
sum a = (-1.9216728320959546e-13,3.035332251481183e-11,9.429222616716636e-12)
sum e = 1.259720768118571e-10
sum de = 2.567669916864021e-15
Info: CFL hydro = 1.4653078960011765 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.4653078960011765 cfl multiplier : 0.9999999999999997 [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.0379e+05 | 99421 | 3.273e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 15986.200671993065 (tsim/hr) [sph::Model][rank=0]
---------------- t = 227.29159567603452, dt = 1.4653078960011765 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99421 min = 99421 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99421 min = 99421 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99421
max = 99421
avg = 99421
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.96 us (1.8%)
patch tree reduce : 1312.00 ns (0.3%)
gen split merge : 692.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1142.00 ns (0.3%)
LB compute : 368.38 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.34 us (71.5%)
central potential accretion : += 1e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (1.389414014223058e-09,-1.2974465690031933e-09,-9.619052726834952e-10)
sum a = (-7.884753455804667e-13,2.975545679498332e-11,1.0454096333923596e-11)
sum e = 1.2597105854305801e-10
sum de = 2.533588128305134e-15
Info: CFL hydro = 1.4151323381651453 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.4151323381651453 cfl multiplier : 0.9999999999999997 [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.0230e+05 | 99420 | 3.289e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 16039.686219724454 (tsim/hr) [sph::Model][rank=0]
---------------- t = 228.7569035720357, dt = 1.4151323381651453 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99420 min = 99420 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99420 min = 99420 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99420
max = 99420
avg = 99420
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.53 us (1.7%)
patch tree reduce : 1583.00 ns (0.4%)
gen split merge : 822.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1042.00 ns (0.3%)
LB compute : 349.25 us (90.2%)
LB move op cnt : 0
LB apply : 3.40 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.39 us (72.4%)
central potential accretion : += 3.0000000000000004e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (1.4031897506780157e-09,-1.2314025223938152e-09,-9.540489210387575e-10)
sum a = (-1.4581460551262749e-12,2.950725320819323e-11,1.1831119401868442e-11)
sum e = 1.2595769226417797e-10
sum de = 2.4640915838582282e-15
Info: CFL hydro = 1.3446780209216933 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.3446780209216933 cfl multiplier : 0.9999999999999997 [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.0129e+05 | 99417 | 3.300e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 15439.082827605005 (tsim/hr) [sph::Model][rank=0]
---------------- t = 230.17203591020083, dt = 1.3446780209216933 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99417 min = 99417 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99417 min = 99417 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99417
max = 99417
avg = 99417
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.56 us (2.2%)
patch tree reduce : 1483.00 ns (0.4%)
gen split merge : 711.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1012.00 ns (0.3%)
LB compute : 330.06 us (93.9%)
LB move op cnt : 0
LB apply : 3.43 us (1.0%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.31 us (70.6%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (1.400888872568139e-09,-1.1921680678869832e-09,-9.376155988545513e-10)
sum a = (-1.9199440561129252e-12,2.8878579919454547e-11,1.2520798433760168e-11)
sum e = 1.2595887954083904e-10
sum de = 2.4319758782360045e-15
Info: CFL hydro = 1.2945793338040796 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.2945793338040796 cfl multiplier : 0.9999999999999997 [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.0354e+05 | 99417 | 3.275e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 14780.08128309885 (tsim/hr) [sph::Model][rank=0]
---------------- t = 231.51671393112252, dt = 1.2945793338040796 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99417 min = 99417 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99417 min = 99417 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99417
max = 99417
avg = 99417
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.62 us (1.8%)
patch tree reduce : 1292.00 ns (0.3%)
gen split merge : 832.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 992.00 ns (0.3%)
LB compute : 357.19 us (94.8%)
LB move op cnt : 0
LB apply : 3.37 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.65 us (63.9%)
central potential accretion : += 2e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (1.410658522798346e-09,-1.1473341127295092e-09,-9.342883131284804e-10)
sum a = (-2.3656995248788944e-12,2.8739606948952457e-11,1.3401032006969376e-11)
sum e = 1.2595037404025114e-10
sum de = 2.374706750862879e-15
Info: CFL hydro = 1.339012490730291 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.339012490730291 cfl multiplier : 0.9999999999999997 [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.0346e+05 | 99415 | 3.276e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 14225.984854557611 (tsim/hr) [sph::Model][rank=0]
---------------- t = 232.8112932649266, dt = 1.339012490730291 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99415 min = 99415 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99415 min = 99415 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99415
max = 99415
avg = 99415
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.26 us (2.0%)
patch tree reduce : 1513.00 ns (0.4%)
gen split merge : 862.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1252.00 ns (0.3%)
LB compute : 345.58 us (94.2%)
LB move op cnt : 0
LB apply : 3.18 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.15 us (69.8%)
central potential accretion : += 1e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (1.4017086842419092e-09,-1.1170462977384754e-09,-9.125641589554684e-10)
sum a = (-2.754667639851513e-12,2.792020540282037e-11,1.3841487374096432e-11)
sum e = 1.25949682459235e-10
sum de = 2.3327696668029214e-15
Info: CFL hydro = 1.3092290964583557 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.3092290964583557 cfl multiplier : 0.9999999999999997 [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.0324e+05 | 99414 | 3.278e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 14703.85132785879 (tsim/hr) [sph::Model][rank=0]
---------------- t = 234.1503057556569, dt = 1.3092290964583557 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99414 min = 99414 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99414 min = 99414 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99414
max = 99414
avg = 99414
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.49 us (2.0%)
patch tree reduce : 1543.00 ns (0.4%)
gen split merge : 922.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1012.00 ns (0.3%)
LB compute : 348.56 us (94.0%)
LB move op cnt : 0
LB apply : 4.04 us (1.1%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.38 us (70.6%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (1.3978050121039352e-09,-1.0809450706396123e-09,-8.940071528834351e-10)
sum a = (-3.1722177938654524e-12,2.7236739909575736e-11,1.444981137422139e-11)
sum e = 1.2595186821272356e-10
sum de = 2.2950844024549113e-15
Info: CFL hydro = 1.2868889166465987 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.2868889166465987 cfl multiplier : 0.9999999999999997 [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.0514e+05 | 99414 | 3.258e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 14466.682237380675 (tsim/hr) [sph::Model][rank=0]
---------------- t = 235.45953485211524, dt = 1.2868889166465987 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99414 min = 99414 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99414 min = 99414 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99414
max = 99414
avg = 99414
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.87 us (1.8%)
patch tree reduce : 1392.00 ns (0.4%)
gen split merge : 1082.00 ns (0.3%)
split / merge op : 0/0
apply split merge : 992.00 ns (0.3%)
LB compute : 360.80 us (94.6%)
LB move op cnt : 0
LB apply : 3.23 us (0.8%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.80 us (71.7%)
central potential accretion : += 1e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (1.388042067481029e-09,-1.054332783922943e-09,-8.719732642754443e-10)
sum a = (-3.5123566963435405e-12,2.641869498979954e-11,1.4807373831126417e-11)
sum e = 1.2594904695682258e-10
sum de = 2.2520735408372142e-15
Info: CFL hydro = 1.2713389049691302 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.2713389049691302 cfl multiplier : 0.9999999999999997 [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 | 2.9520e+05 | 99413 | 3.368e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 13756.62733236118 (tsim/hr) [sph::Model][rank=0]
---------------- t = 236.74642376876184, dt = 1.2713389049691302 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99413 min = 99413 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99413 min = 99413 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99413
max = 99413
avg = 99413
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.25 us (1.8%)
patch tree reduce : 1353.00 ns (0.4%)
gen split merge : 792.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 992.00 ns (0.3%)
LB compute : 337.11 us (94.4%)
LB move op cnt : 0
LB apply : 3.83 us (1.1%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.45 us (70.6%)
central potential accretion : += 1e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (1.3841336998557308e-09,-1.011804175983024e-09,-8.490521269548631e-10)
sum a = (-3.9860190378484735e-12,2.5654399927379462e-11,1.5565584487372692e-11)
sum e = 1.2594630946008015e-10
sum de = 2.2050674857843615e-15
Info: CFL hydro = 1.2624303440205957 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.2624303440205957 cfl multiplier : 0.9999999999999997 [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.0378e+05 | 99412 | 3.273e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 13985.578837276893 (tsim/hr) [sph::Model][rank=0]
---------------- t = 238.01776267373097, dt = 1.2624303440205957 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99412 min = 99412 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99412 min = 99412 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99412
max = 99412
avg = 99412
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.72 us (1.8%)
patch tree reduce : 1423.00 ns (0.4%)
gen split merge : 872.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1403.00 ns (0.4%)
LB compute : 345.07 us (94.3%)
LB move op cnt : 0
LB apply : 3.14 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.22 us (70.9%)
central potential accretion : += 2e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (1.374920023462032e-09,-9.781713680107519e-10,-8.228291006338532e-10)
sum a = (-4.384039310257225e-12,2.476175575834644e-11,1.608637894644923e-11)
sum e = 1.2593856612462357e-10
sum de = 2.1492258733314657e-15
Info: CFL hydro = 1.0657487239286776 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.0657487239286776 cfl multiplier : 0.9999999999999997 [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.0326e+05 | 99410 | 3.278e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 13864.111678540397 (tsim/hr) [sph::Model][rank=0]
---------------- t = 239.28019301775157, dt = 1.0657487239286776 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99410 min = 99410 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99410 min = 99410 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99410
max = 99410
avg = 99410
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.23 us (2.0%)
patch tree reduce : 1272.00 ns (0.4%)
gen split merge : 731.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1032.00 ns (0.3%)
LB compute : 340.73 us (94.2%)
LB move op cnt : 0
LB apply : 3.55 us (1.0%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.62 us (73.2%)
central potential accretion : += 1e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (1.365375487257739e-09,-9.611480015065028e-10,-8.049585524550426e-10)
sum a = (-4.6112267881291e-12,2.409621553625653e-11,1.6255059969310125e-11)
sum e = 1.2593080474206186e-10
sum de = 2.1123491222083185e-15
Info: CFL hydro = 1.0744922617664094 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.0744922617664094 cfl multiplier : 0.9999999999999997 [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.0418e+05 | 99409 | 3.268e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 11739.940182759814 (tsim/hr) [sph::Model][rank=0]
---------------- t = 240.34594174168024, dt = 1.0744922617664094 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99409 min = 99409 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99409 min = 99409 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99409
max = 99409
avg = 99409
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.56 us (1.9%)
patch tree reduce : 1453.00 ns (0.4%)
gen split merge : 852.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1312.00 ns (0.3%)
LB compute : 368.72 us (94.4%)
LB move op cnt : 0
LB apply : 3.29 us (0.8%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.61 us (70.5%)
central potential accretion : += 2e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (1.3650821489807924e-09,-9.179131037349549e-10,-7.817853615290424e-10)
sum a = (-5.041106055147225e-12,2.338480472812331e-11,1.7093173272321314e-11)
sum e = 1.2592307593090528e-10
sum de = 2.0703402606300214e-15
Info: CFL hydro = 1.061787198079664 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.061787198079664 cfl multiplier : 0.9999999999999997 [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.0475e+05 | 99407 | 3.262e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 11858.629059887013 (tsim/hr) [sph::Model][rank=0]
---------------- t = 241.42043400344664, dt = 1.061787198079664 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99407 min = 99407 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99407 min = 99407 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99407
max = 99407
avg = 99407
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 8.51 us (2.3%)
patch tree reduce : 1784.00 ns (0.5%)
gen split merge : 902.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1453.00 ns (0.4%)
LB compute : 349.77 us (93.5%)
LB move op cnt : 0
LB apply : 3.63 us (1.0%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.24 us (69.3%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (1.3595866982421935e-09,-8.934234229867417e-10,-7.634266952978449e-10)
sum a = (-5.315902938160467e-12,2.2748903143095653e-11,1.7457503044185168e-11)
sum e = 1.259249645533666e-10
sum de = 2.037047176547747e-15
Info: CFL hydro = 1.0870648786738213 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.0870648786738213 cfl multiplier : 0.9999999999999997 [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.0585e+05 | 99407 | 3.250e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 11760.511374787246 (tsim/hr) [sph::Model][rank=0]
---------------- t = 242.4822212015263, dt = 1.0870648786738213 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99407 min = 99407 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99407 min = 99407 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99407
max = 99407
avg = 99407
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.65 us (1.9%)
patch tree reduce : 1934.00 ns (0.6%)
gen split merge : 721.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1091.00 ns (0.3%)
LB compute : 327.68 us (94.0%)
LB move op cnt : 0
LB apply : 3.14 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.20 us (69.8%)
central potential accretion : += 2e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Warning: smoothing length is not converged, rerunning the iterator ... [Smoothinglength][rank=0]
largest h = 0.010160740294295992 unconverged cnt = 3
Info: conservation infos : [sph::Model][rank=0]
sum v = (1.3570863937924415e-09,-8.506932234573935e-10,-7.368090374651957e-10)
sum a = (-5.744791882804585e-12,2.1952465532842557e-11,1.8266585756589967e-11)
sum e = 1.259175966096401e-10
sum de = 1.9846790258516893e-15
Info: CFL hydro = 1.10170241202598 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.10170241202598 cfl multiplier : 0.9999999999999997 [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.9719e+05 | 99405 | 5.041e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 7763.234963695149 (tsim/hr) [sph::Model][rank=0]
---------------- t = 243.56928608020013, dt = 1.10170241202598 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99405 min = 99405 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99405 min = 99405 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99405
max = 99405
avg = 99405
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.00 us (1.8%)
patch tree reduce : 1443.00 ns (0.4%)
gen split merge : 812.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1032.00 ns (0.3%)
LB compute : 363.21 us (94.7%)
LB move op cnt : 0
LB apply : 3.36 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.44 us (71.3%)
central potential accretion : += 1e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (1.3460430868811264e-09,-8.35804965943181e-10,-7.164369272482575e-10)
sum a = (-5.944874281607375e-12,2.1223407372252105e-11,1.836342281894496e-11)
sum e = 1.259150435487798e-10
sum de = 1.9456440239548866e-15
Info: CFL hydro = 1.0530754583049633 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.0530754583049633 cfl multiplier : 0.9999999999999997 [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 | 2.9862e+05 | 99404 | 3.329e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 11914.542145200388 (tsim/hr) [sph::Model][rank=0]
---------------- t = 244.67098849222612, dt = 1.0530754583049633 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99404 min = 99404 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99404 min = 99404 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99404
max = 99404
avg = 99404
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.57 us (1.9%)
patch tree reduce : 1292.00 ns (0.4%)
gen split merge : 862.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1012.00 ns (0.3%)
LB compute : 333.51 us (94.4%)
LB move op cnt : 0
LB apply : 3.27 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.35 us (70.4%)
central potential accretion : += 1e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (1.345497620588148e-09,-8.100662172595339e-10,-7.040759833278472e-10)
sum a = (-6.200391875765818e-12,2.0819494474474216e-11,1.877042035575963e-11)
sum e = 1.2591091352193094e-10
sum de = 1.898687755028488e-15
Info: CFL hydro = 1.0851842001349783 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.0851842001349783 cfl multiplier : 0.9999999999999997 [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.0478e+05 | 99403 | 3.262e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 11623.666713890796 (tsim/hr) [sph::Model][rank=0]
---------------- t = 245.72406395053108, dt = 1.0851842001349783 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99403 min = 99403 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99403 min = 99403 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99403
max = 99403
avg = 99403
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.70 us (1.8%)
patch tree reduce : 1683.00 ns (0.5%)
gen split merge : 772.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 992.00 ns (0.3%)
LB compute : 351.87 us (94.3%)
LB move op cnt : 0
LB apply : 3.87 us (1.0%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.31 us (70.6%)
central potential accretion : += 4e-08
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (1.3497840896939062e-09,-7.701655254024549e-10,-6.878934593518991e-10)
sum a = (-6.548028968634193e-12,2.0387972736573538e-11,1.9532052346279177e-11)
sum e = 1.258934081949036e-10
sum de = 1.8292165362540297e-15
Info: CFL hydro = 1.1273216032973585 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.1273216032973585 cfl multiplier : 0.9999999999999997 [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.0406e+05 | 99399 | 3.269e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 11950.606708287023 (tsim/hr) [sph::Model][rank=0]
---------------- t = 246.80924815066606, dt = 0.7804731748453833 ----------------
Info: summary : [LoadBalance][rank=0]
Info: - strategy "psweep" : max = 99399 min = 99399 [LoadBalance][rank=0]
Info: - strategy "round robin" : max = 99399 min = 99399 [LoadBalance][rank=0]
Info: Loadbalance stats : [LoadBalance][rank=0]
npatch = 1
min = 99399
max = 99399
avg = 99399
efficiency = 100.00%
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 7.03 us (1.6%)
patch tree reduce : 1493.00 ns (0.3%)
gen split merge : 822.00 ns (0.2%)
split / merge op : 0/0
apply split merge : 1152.00 ns (0.3%)
LB compute : 426.39 us (95.0%)
LB move op cnt : 0
LB apply : 3.92 us (0.9%)
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 2.47 us (71.4%)
Info: free boundaries skipping geometry update [PositionUpdated][rank=0]
Info: conservation infos : [sph::Model][rank=0]
sum v = (1.344539514202291e-09,-7.546271364229857e-10,-6.724877384019669e-10)
sum a = (-6.724460721338167e-12,1.9882082187210027e-11,1.9739561005745793e-11)
sum e = 1.2588867433982636e-10
sum de = 1.8066722169120247e-15
Info: CFL hydro = 1.1650897252646046 sink sink = inf [SPH][rank=0]
Info: cfl dt = 1.1650897252646046 cfl multiplier : 0.9999999999999997 [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.0721e+05 | 99399 | 3.236e-01 | 0 % | 0 % | 1.16 GB |
---------------------------------------------------------------------------------------
Info: estimated rate : 8683.959247989085 (tsim/hr) [sph::Model][rank=0]
Info: iteration since start : 187 [SPH][rank=0]
Info: time since start : 1441.4919040220002 (s) [SPH][rank=0]
Info: dump to _to_trash/black_hole_disc_lense_thirring_100000/dump/dump_0000010.vtk [VTK Dump][rank=0]
- took 7.78 ms, bandwidth = 681.93 MB/s
Info: Dumping state to _to_trash/black_hole_disc_lense_thirring_100000/dump/dump_0000010.sham [SPH][rank=0]
Info: Scheduler step timings : [Scheduler][rank=0]
metadata sync : 6.43 us (54.9%)
Info: dump to _to_trash/black_hole_disc_lense_thirring_100000/dump/dump_0000010.sham [Shamrock Dump][rank=0]
- took 11.23 ms, bandwidth = 1013.40 MB/s
Info: compute_column_integ field_name: rho, center: (0,0,0), delta_x: (1.1845115302733742,0,0), delta_y: (0,1.1845115302733742,0), nx: 1024, ny: 1024 [sph::CartesianRender][rank=0]
Info: compute_column_integ took 620.05 ms [sph::CartesianRender][rank=0]
Info: compute_column_integ field_name: vxyz, center: (0,0,0), delta_x: (1.1845115302733742,0,0), delta_y: (0,1.1845115302733742,0), nx: 1024, ny: 1024 [sph::CartesianRender][rank=0]
Info: compute_column_integ took 625.55 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)
505 import matplotlib
506 import matplotlib.pyplot as plt
507
508 # Uncomment this and replace by you dump folder, here since it is just above i comment it out
509 # dump_folder = "my_masterpiece"
510 # dump_folder += "/"
511
512
513 def plot_rho_integ(metadata, arr_rho, iplot):
514
515 ext = metadata["extent"]
516
517 dpi = 200
518
519 # Reset the figure using the same memory as the last one
520 plt.figure(num=1, clear=True, dpi=dpi)
521 import copy
522
523 my_cmap = matplotlib.colormaps["gist_heat"].copy() # copy the default cmap
524 my_cmap.set_bad(color="black")
525
526 res = plt.imshow(
527 arr_rho, cmap=my_cmap, origin="lower", extent=ext, norm="log", vmin=1e-6, vmax=1e-2
528 )
529
530 plt.xlabel("x")
531 plt.ylabel("y")
532 plt.title(f"t = {metadata['time']:0.3f} [seconds]")
533
534 cbar = plt.colorbar(res, extend="both")
535 cbar.set_label(r"$\int \rho \, \mathrm{d}z$ [code unit]")
536
537 plt.savefig(plot_folder + "rho_integ_{:04}.png".format(iplot))
538 plt.close()
539
540
541 def plot_vz_integ(metadata, arr_vz, iplot):
542 ext = metadata["extent"]
543 dpi = 200
544 plt.figure(num=1, clear=True, dpi=dpi)
545
546 # if you want an adaptive colorbar
547 # v_ext = np.max(arr_vz)
548 # v_ext = max(v_ext, np.abs(np.min(arr_vz)))
549 v_ext = 1e-6
550
551 res = plt.imshow(arr_vz, cmap="seismic", origin="lower", extent=ext, vmin=-v_ext, vmax=v_ext)
552 plt.xlabel("x")
553 plt.ylabel("y")
554 plt.title(f"t = {metadata['time']:0.3f} [seconds]")
555
556 cbar = plt.colorbar(res, extend="both")
557 cbar.set_label(r"$\int v_z \, \mathrm{d}z$ [code unit]")
558
559 plt.savefig(plot_folder + "vz_integ_{:04}.png".format(iplot))
560 plt.close()
561
562
563 def get_list_dumps_id():
564 import glob
565
566 list_files = glob.glob(plot_folder + "rho_integ_*.npy")
567 list_files.sort()
568 list_dumps_id = []
569 for f in list_files:
570 list_dumps_id.append(int(f.split("_")[-1].split(".")[0]))
571 return list_dumps_id
572
573
574 def load_rho_integ(iplot):
575 with open(plot_folder + f"rho_integ_{iplot:07}.json") as fp:
576 metadata = json.load(fp)
577 return np.load(plot_folder + f"rho_integ_{iplot:07}.npy"), metadata
578
579
580 def load_vxyz_integ(iplot):
581 with open(plot_folder + f"vxyz_integ_{iplot:07}.json") as fp:
582 metadata = json.load(fp)
583 return np.load(plot_folder + f"vxyz_integ_{iplot:07}.npy"), metadata
584
585
586 if shamrock.sys.world_rank() == 0:
587 for iplot in get_list_dumps_id():
588 print("Rendering rho integ plot for dump", iplot)
589 arr_rho, metadata = load_rho_integ(iplot)
590 plot_rho_integ(metadata, arr_rho, iplot)
591
592 print("Rendering vxyz integ plot for dump", iplot)
593 arr_vxyz, metadata = load_vxyz_integ(iplot)
594 plot_vz_integ(metadata, arr_vxyz[:, :, 2], iplot)
Rendering rho integ plot for dump 0
Rendering vxyz integ plot for dump 0
Rendering rho integ plot for dump 1
Rendering vxyz integ plot for dump 1
Rendering rho integ plot for dump 2
Rendering vxyz integ plot for dump 2
Rendering rho integ plot for dump 3
Rendering vxyz integ plot for dump 3
Rendering rho integ plot for dump 4
Rendering vxyz integ plot for dump 4
Rendering rho integ plot for dump 5
Rendering vxyz integ plot for dump 5
Rendering rho integ plot for dump 6
Rendering vxyz integ plot for dump 6
Rendering rho integ plot for dump 7
Rendering vxyz integ plot for dump 7
Rendering rho integ plot for dump 8
Rendering vxyz integ plot for dump 8
Rendering rho integ plot for dump 9
Rendering vxyz integ plot for dump 9
Rendering rho integ plot for dump 10
Rendering vxyz integ plot for dump 10
Make gif for the doc (plot_to_gif.py)#
Convert PNG sequence to Image sequence in mpl
603 import matplotlib.animation as animation
604
605
606 def show_image_sequence(glob_str, render_gif):
607
608 if render_gif and shamrock.sys.world_rank() == 0:
609
610 import glob
611
612 files = sorted(glob.glob(glob_str))
613
614 from PIL import Image
615
616 image_array = []
617 for my_file in files:
618 image = Image.open(my_file)
619 image_array.append(image)
620
621 if not image_array:
622 raise RuntimeError(f"Warning: No images found for glob pattern: {glob_str}")
623
624 pixel_x, pixel_y = image_array[0].size
625
626 # Create the figure and axes objects
627 # Remove axes, ticks, and frame & set aspect ratio
628 dpi = 200
629 fig = plt.figure(dpi=dpi)
630 plt.gca().set_position((0, 0, 1, 1))
631 plt.gcf().set_size_inches(pixel_x / dpi, pixel_y / dpi)
632 plt.axis("off")
633
634 # Set the initial image with correct aspect ratio
635 im = plt.imshow(image_array[0], animated=True, aspect="auto")
636
637 def update(i):
638 im.set_array(image_array[i])
639 return (im,)
640
641 # Create the animation object
642 ani = animation.FuncAnimation(
643 fig,
644 update,
645 frames=len(image_array),
646 interval=50,
647 blit=True,
648 repeat_delay=10,
649 )
650
651 return ani
Do it for rho integ
657 render_gif = True
658 glob_str = os.path.join(plot_folder, "rho_integ_*.png")
659
660 # If the animation is not returned only a static image will be shown in the doc
661 ani = show_image_sequence(glob_str, render_gif)
662
663 if render_gif and shamrock.sys.world_rank() == 0:
664 # To save the animation using Pillow as a gif
665 writer = animation.PillowWriter(fps=15, metadata=dict(artist="Me"), bitrate=1800)
666 ani.save(analysis_folder + "rho_integ.gif", writer=writer)
667
668 # Show the animation
669 plt.show()
Do it for rho integ
673 render_gif = True
674 glob_str = os.path.join(plot_folder, "vz_integ_*.png")
675
676 # If the animation is not returned only a static image will be shown in the doc
677 ani = show_image_sequence(glob_str, render_gif)
678
679 if render_gif and shamrock.sys.world_rank() == 0:
680 # To save the animation using Pillow as a gif
681 writer = animation.PillowWriter(fps=15, metadata=dict(artist="Me"), bitrate=1800)
682 ani.save(analysis_folder + "vz_integ.gif", writer=writer)
683
684 # Show the animation
685 plt.show()
helper function to load data from JSON files
690 def load_data_from_json(filename, key):
691 filepath = os.path.join(analysis_folder, filename)
692 with open(filepath, "r") as fp:
693 data = json.load(fp)[key]
694 t = [d["t"] for d in data]
695 values = [d[key] for d in data]
696 return t, values
load the json file for barycenter
701 t, barycenter = load_data_from_json("barycenter.json", "barycenter")
702 barycenter_x = [d[0] for d in barycenter]
703 barycenter_y = [d[1] for d in barycenter]
704 barycenter_z = [d[2] for d in barycenter]
705
706 plt.figure(figsize=(8, 5), dpi=200)
707
708 plt.plot(t, barycenter_x)
709 plt.plot(t, barycenter_y)
710 plt.plot(t, barycenter_z)
711 plt.xlabel("t [seconds]")
712 plt.ylabel("barycenter")
713 plt.legend(["x", "y", "z"])
714 plt.savefig(analysis_folder + "barycenter.png")
715 plt.show()

load the json file for disc_mass
719 t, disc_mass = load_data_from_json("disc_mass.json", "disc_mass")
720
721 plt.figure(figsize=(8, 5), dpi=200)
722
723 plt.plot(t, disc_mass)
724 plt.xlabel("t [seconds]")
725 plt.ylabel("disc_mass")
726 plt.savefig(analysis_folder + "disc_mass.png")
727 plt.show()

load the json file for total_momentum
731 t, total_momentum = load_data_from_json("total_momentum.json", "total_momentum")
732 total_momentum_x = [d[0] for d in total_momentum]
733 total_momentum_y = [d[1] for d in total_momentum]
734 total_momentum_z = [d[2] for d in total_momentum]
735
736 plt.figure(figsize=(8, 5), dpi=200)
737
738 plt.plot(t, total_momentum_x)
739 plt.plot(t, total_momentum_y)
740 plt.plot(t, total_momentum_z)
741 plt.xlabel("t [seconds]")
742 plt.ylabel("total_momentum")
743 plt.legend(["x", "y", "z"])
744 plt.savefig(analysis_folder + "total_momentum.png")
745 plt.show()

load the json file for energies
749 t, potential_energy = load_data_from_json("potential_energy.json", "potential_energy")
750 _, kinetic_energy = load_data_from_json("kinetic_energy.json", "kinetic_energy")
751
752 total_energy = [p + k for p, k in zip(potential_energy, kinetic_energy)]
753
754 plt.figure(figsize=(8, 5), dpi=200)
755 plt.plot(t, potential_energy)
756 plt.plot(t, kinetic_energy)
757 plt.plot(t, total_energy)
758 plt.xlabel("t [seconds]")
759 plt.ylabel("energy")
760 plt.legend(["potential_energy", "kinetic_energy", "total_energy"])
761 plt.savefig(analysis_folder + "energies.png")
762 plt.show()

load the json file for sim_time_delta
766 t, sim_time_delta = load_data_from_json("sim_time_delta.json", "sim_time_delta")
767
768 plt.figure(figsize=(8, 5), dpi=200)
769 plt.plot(t, sim_time_delta)
770 plt.xlabel("t [seconds]")
771 plt.ylabel("sim_time_delta")
772 plt.savefig(analysis_folder + "sim_time_delta.png")
773 plt.show()

load the json file for sim_step_count_delta
777 t, sim_step_count_delta = load_data_from_json("sim_step_count_delta.json", "sim_step_count_delta")
778
779 plt.figure(figsize=(8, 5), dpi=200)
780 plt.plot(t, sim_step_count_delta)
781 plt.xlabel("t [seconds]")
782 plt.ylabel("sim_step_count_delta")
783 plt.savefig(analysis_folder + "sim_step_count_delta.png")
784 plt.show()

Time per step
788 t, sim_time_delta = load_data_from_json("sim_time_delta.json", "sim_time_delta")
789 _, sim_step_count_delta = load_data_from_json("sim_step_count_delta.json", "sim_step_count_delta")
790 _, part_count = load_data_from_json("part_count.json", "part_count")
791
792 time_per_step = []
793
794 for td, sc, pc in zip(sim_time_delta, sim_step_count_delta, part_count):
795 if sc > 0:
796 time_per_step.append(td / sc)
797 else:
798 # NAN here because the step count is 0
799 time_per_step.append(np.nan)
800
801 plt.figure(figsize=(8, 5), dpi=200)
802 plt.plot(t, time_per_step, "+-")
803 plt.xlabel("t [seconds]")
804 plt.ylabel("time_per_step")
805 plt.savefig(analysis_folder + "time_per_step.png")
806 plt.show()
807
808 rate = []
809
810 for td, sc, pc in zip(sim_time_delta, sim_step_count_delta, part_count):
811 if sc > 0:
812 rate.append(pc / (td / sc))
813 else:
814 # NAN here because the step count is 0
815 rate.append(np.nan)
816
817 plt.figure(figsize=(8, 5), dpi=200)
818 plt.plot(t, rate, "+-")
819 plt.xlabel("t [seconds]")
820 plt.ylabel("Particles / second")
821 plt.yscale("log")
822 plt.savefig(analysis_folder + "rate.png")
823 plt.show()
Total running time of the script: (2 minutes 15.200 seconds)
Estimated memory usage: 326 MB